diff --git a/doc/src/Commands_all.txt b/doc/src/Commands_all.txt index 6f54681342b14d64ba543d4f021fcb1ee7c078b3..c0b8c4516d3fc6a09becf7c03101433cb6768b8f 100644 --- a/doc/src/Commands_all.txt +++ b/doc/src/Commands_all.txt @@ -59,6 +59,7 @@ An alphabetic list of all LAMMPS commands. "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, diff --git a/doc/src/Commands_fix.txt b/doc/src/Commands_fix.txt index 77684390bdba63407d4ae3b6248896607956db90..6d8f67b503f2d53e05774e862898e91602ebe98c 100644 --- a/doc/src/Commands_fix.txt +++ b/doc/src/Commands_fix.txt @@ -78,6 +78,8 @@ OPT. "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, @@ -108,7 +110,7 @@ OPT. "nph/asphere (o)"_fix_nph_asphere.html, "nph/body"_fix_nph_body.html, "nph/eff"_fix_nh_eff.html, -"nph/sphere (ko)"_fix_nph_sphere.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, @@ -128,7 +130,7 @@ OPT. "nve/line"_fix_nve_line.html, "nve/manifold/rattle"_fix_nve_manifold_rattle.html, "nve/noforce"_fix_nve_noforce.html, -"nve/sphere (o)"_fix_nve_sphere.html, +"nve/sphere (ko)"_fix_nve_sphere.html, "nve/spin"_fix_nve_spin.html, "nve/tri"_fix_nve_tri.html, "nvk"_fix_nvk.html, @@ -147,6 +149,7 @@ OPT. "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, diff --git a/doc/src/Packages_user.txt b/doc/src/Packages_user.txt index e1269b0d0ca5713a37e3975b9eaf2a1818244ad6..463b8ab2e715d8eface14ecb952ee27eb5b96649 100644 --- a/doc/src/Packages_user.txt +++ b/doc/src/Packages_user.txt @@ -68,7 +68,7 @@ Package, Description, Doc page, Example, Library "USER-QUIP"_Packages_details.html#PKG-USER-QUIP, QUIP/libatoms interface,"pair_style quip"_pair_quip.html, USER/quip, ext "USER-REAXC"_Packages_details.html#PKG-USER-REAXC, ReaxFF potential (C/C++) ,"pair_style reaxc"_pair_reaxc.html, reax, no "USER-SCAFACOS"_Packages_details.html#PKG-USER-SCAFACOS, wrapper on ScaFaCoS solver,"kspace_style scafacos"_kspace_style.html, USER/scafacos, ext -"USER-SDPD"_Packages_details.html#PKG-USER-SDPD, smoothed dissipative particle dynamics,"pair_style sdpd/taitwater/isothermal"_pair_sdpd_taitwater_isothermal, USER/sdpd, no +"USER-SDPD"_Packages_details.html#PKG-USER-SDPD, smoothed dissipative particle dynamics,"pair_style sdpd/taitwater/isothermal"_pair_sdpd_taitwater_isothermal.html, USER/sdpd, no "USER-SMD"_Packages_details.html#PKG-USER-SMD, smoothed Mach dynamics,"SMD User Guide"_PDF/SMD_LAMMPS_userguide.pdf, USER/smd, ext "USER-SMTBQ"_Packages_details.html#PKG-USER-SMTBQ, second moment tight binding QEq potential,"pair_style smtbq"_pair_smtbq.html, USER/smtbq, no "USER-SPH"_Packages_details.html#PKG-USER-SPH, smoothed particle hydrodynamics,"SPH User Guide"_PDF/SPH_LAMMPS_userguide.pdf, USER/sph, no diff --git a/doc/src/commands_list.txt b/doc/src/commands_list.txt index db3ef36ddf074cb133d04a95dd5961ae86955e5c..78fa9fbf87a02e792cd664de51580b967ed360ae 100644 --- a/doc/src/commands_list.txt +++ b/doc/src/commands_list.txt @@ -44,6 +44,7 @@ Commands :h1 fix_modify group group2ndx + hyper if improper_coeff improper_style diff --git a/doc/src/compute.txt b/doc/src/compute.txt index 857795ffe51fc1538d61815900780e6c51ef0103..761d3fe29f5c5305bdd2c4094255e550c519908c 100644 --- a/doc/src/compute.txt +++ b/doc/src/compute.txt @@ -176,6 +176,7 @@ compute"_Commands_compute.html doc page are followed by one or more of (g,i,k,o,t) to indicate which accelerated styles exist. "ackland/atom"_compute_ackland_atom.html - +"adf"_compute_adf.html - angular distribution function "aggregate/atom"_compute_cluster_atom.html - aggregate ID for each atom "angle"_compute_angle.html - "angle/local"_compute_angle_local.html - diff --git a/doc/src/fix.txt b/doc/src/fix.txt index 8d00fa987d1429e057daab9d23aa894182f5c20d..1a216319b0bb8deafcd8d3a560cf9a1f8d57f742 100644 --- a/doc/src/fix.txt +++ b/doc/src/fix.txt @@ -221,6 +221,8 @@ accelerated styles exist. "grem"_fix_grem.html - "halt"_fix_halt.html - terminate a dynamics run or minimization "heat"_fix_heat.html - add/subtract momentum-conserving heat +"hyper/global"_fix_hyper_global.html - global hyperdynamics +"hyper/local"_fix_hyper_local.html - local hyperdynamics "imd"_fix_imd.html - "indent"_fix_indent.html - impose force due to an indenter "ipi"_fix_ipi.html - @@ -238,6 +240,7 @@ accelerated styles exist. "manifoldforce"_fix_manifoldforce.html - "meso"_fix_meso.html - "meso"_fix_meso_move.html - move mesoscopic SPH/SDPD particles in a prescribed fashion +"meso/move"_fix_meso_move.html - "meso/stationary"_fix_meso_stationary.html - "momentum"_fix_momentum.html - zero the linear and/or angular momentum of a group of atoms "move"_fix_move.html - move atoms in a prescribed fashion @@ -293,6 +296,7 @@ accelerated styles exist. "phonon"_fix_phonon.html - "pimd"_fix_pimd.html - "planeforce"_fix_planeforce.html - constrain atoms to move in a plane +"plumed"_fix_plumed.html - wrapper on PLUMED free energy library "poems"_fix_poems.html - constrain clusters of atoms to move as coupled rigid bodies "pour"_fix_pour.html - pour new atoms/molecules into a granular simulation domain "precession/spin"_fix_precession_spin.html - diff --git a/doc/src/fix_hyper_global.txt b/doc/src/fix_hyper_global.txt new file mode 100644 index 0000000000000000000000000000000000000000..4b9e971e14c734939df2b053c685acd37c33d1fd --- /dev/null +++ b/doc/src/fix_hyper_global.txt @@ -0,0 +1,260 @@ +"LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c + +:link(lws,http://lammps.sandia.gov) +:link(ld,Manual.html) +:link(lc,Section_commands.html#comm) + +:line + +fix hyper/global command :h3 + +[Syntax:] + +fix ID group-ID hyper/global cutbond qfactor Vmax Tequil :pre + +ID, group-ID are documented in "fix"_fix.html command +hyper/global = style name of this fix command +cutbond = max distance at which a pair of atoms is considered bonded (distance units) +qfactor = max strain at which bias potential goes to 0.0 (unitless) +Vmax = height of bias potential (energy units) +Tequil = equilibration temperature (temperature units) :ul + +[Examples:] + +fix 1 all hyper/global 1.0 0.3 0.8 300.0 :pre + +[Description:] + +This fix is meant to be used with the "hyper"_hyper.html command to +perform a bond-boost global hyperdynamics (GHD) simulation. The role +of this fix is to a select a single pair of atoms in the system at +each timestep to add a global bias potential to, which will alter the +dynamics of the system in a manner that effectively accelerates time. +This is in contrast to the "fix hyper/local"_fix_hyper_local.html +command, which can be user to perform a local hyperdynamics (LHD) +simulation, by adding a local bias potential to multiple pairs of +atoms at each timestep. GHD can time accelerate a small simulation +with up to a few 100 atoms. For larger systems, LHD is needed to +achieve good time acceleration. + +For a system that undergoes rare transition events, where one or more +atoms move over an energy barrier to a new potential energy basin, the +effect of the bias potential is to induce more rapid transitions. +This can lead to a dramatic speed-up in the rate at which events +occurs, without altering their relative frequencies, thus leading to +an overall increase in the elapsed real time of the simulation as +compared to running for the same number of timesteps with normal MD. +See the "hyper"_hyper.html doc page for a more general discussion of +hyperdynamics and citations that explain both GHD and LHD. + +The equations and logic used by this fix and described here to perform +GHD follow the description given in "(Voter2013)"_#Voter2013ghd. The +bond-boost form of a bias potential for HD is due to Miron and +Fichthorn as described in "(Miron)"_#Mironghd. In LAMMPS we use a +simplified version of bond-boost GHD where a single bond in the system +is biased at any one timestep. + +Bonds are defined between each pair of I,J atoms whose R0ij distance +is less than {cutbond}, when the system is in a quenched state +(minimum) energy. Note that these are not "bonds" in a covalent +sense. A bond is simply any pair of atoms that meet the distance +criterion. {Cutbond} is an argument to this fix; it is discussed +below. A bond is only formed if one or both of the I.J atoms are in +the specified group. + +The current strain of bond IJ (when running dynamics) is defined as + +Eij = (Rij - R0ij) / R0ij :pre + +where Rij is the current distance between atoms I,J, and R0ij is the +equilibrium distance in the quenched state. + +The bias energy Vij of any bond IJ is defined as + +Vij = Vmax * (1 - (Eij/q)^2) for abs(Eij) < qfactor + = 0 otherwise :pre + +where the prefactor {Vmax} and the cutoff {qfactor} are arguments to +this fix; they are discussed below. This functional form is an +inverse parabola centered at 0.0 with height Vmax and which goes to +0.0 at +/- qfactor. + +Let Emax = the maximum of abs(Eij) for all IJ bonds in the system on a +given timestep. On that step, Vij is added as a bias potential to +only the single bond with strain Emax, call it Vij(max). Note that +Vij(max) will be 0.0 if Emax >= qfactor on that timestep. Also note +that Vij(max) is added to the normal interatomic potential that is +computed between all atoms in the system at every step. + +The derivative of Vij(max) with respect to the position of each atom +in the Emax bond gives a bias force Fij(max) acting on the bond as + +Fij(max) = - dVij(max)/dEij = 2 Vmax Eij / qfactor^2 for abs(Eij) < qfactor + = 0 otherwise :pre + +which can be decomposed into an equal and opposite force acting on +only the two I,J atoms in the Emax bond. + +The time boost factor for the system is given each timestep I by + +Bi = exp(beta * Vij(max)) :pre + +where beta = 1/kTequil, and {Tequil} is the temperature of the system +and an argument to this fix. Note that Bi >= 1 at every step. + +NOTE: To run GHD, the input script must also use the "fix +langevin"_fix_langevin.html command to thermostat the atoms at the +same {Tequil} as specified by this fix, so that the system is running +constant-temperature (NVT) dynamics. LAMMPS does not check that this +is done. + +The elapsed time t_hyper for a GHD simulation running for {N} +timesteps is simply + +t_hyper = Sum (i = 1 to N) Bi * dt :pre + +where dt is the timestep size defined by the "timestep"_timestep.html +command. The effective time acceleration due to GHD is thus t_hyper / +N*dt, where N*dt is elapsed time for a normal MD run of N timesteps. + +Note that in GHD, the boost factor varies from timestep to timestep. +Likewise, which bond has Emax strain and thus which pair of atoms the +bias potential is added to, will also vary from timestep to timestep. +This is in contrast to local hyperdynamics (LHD) where the boost +factor is an input parameter; see the "fix +hyper/local"_fix_hyper_local.html doc page for details. + +:line + +Here is additional information on the input parameters for GHD. + +The {cutbond} argument is the cutoff distance for defining bonds +between pairs of nearby atoms. A pair of I,J atoms in their +equilibrium, minimum-energy configuration, which are separated by a +distance Rij < {cutbond}, are flagged as a bonded pair. Setting +{cubond} to be ~25% larger than the nearest-neighbor distance in a +crystalline lattice is a typical choice for solids, so that bonds +exist only between nearest neighbor pairs. + +The {qfactor} argument is the limiting strain at which the bias +potential goes to 0.0. It is dimensionless, so a value of 0.3 means a +bond distance can be up to 30% larger or 30% smaller than the +equilibrium (quenched) R0ij distance and the two atoms in the bond +could still experience a non-zero bias force. + +If {qfactor} is set too large, then transitions from one energy basin +to another are affected because the bias potential is non-zero at the +transition state (e.g. saddle point). If {qfactor} is set too small +than little boost is achieved because the Eij strain of some bond in +the system will (nearly) always exceed {qfactor}. A value of 0.3 for +{qfactor} is typically reasonable. + +The {Vmax} argument is the prefactor on the bias potential. Ideally, +tt should be set to a value slightly less than the smallest barrier +height for an event to occur. Otherwise the applied bias potential +may be large enough (when added to the interatomic potential) to +produce a local energy basin with a maxima in the center. This can +produce artificial energy minima in the same basin that trap an atom. +Or if {Vmax} is even larger, it may induce an atom(s) to rapidly +transition to another energy basin. Both cases are "bad dynamics" +which violate the assumptions of GHD that guarantee an accelerated +time-accurate trajectory of the system. + +Note that if {Vmax} is set too small, the GHD simulation will run +correctly. There will just be fewer events because the hyper time +(t_hyper equation above) will be shorter. + +NOTE: If you have no physical intuition as to the smallest barrier +height in your system, a reasonable strategy to determine the largest +{Vmax} you can use for an LHD model, is to run a sequence of +simulations with smaller and smaller {Vmax} values, until the event +rate does not change. + +The {Tequil} argument is the temperature at which the system is +simulated; see the comment above about the "fix +langevin"_fix_langevin.html thermostatting. It is also part of the +beta term in the exponential factor that determines how much boost is +achieved as a function of the bias potential. + +In general, the lower the value of {Tequil} and the higher the value +of {Vmax}, the more boost will be achievable by the GHD algorithm. + +: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 energy of the bias potential to the the system's +potential energy as part of "thermodynamic output"_thermo_style.html. + +This fix computes a global scalar and global vector of length 11, which +can be accessed by various "output commands"_Howto_output.html. The +scalar is the magnitude of the bias potential (energy units) applied on +the current timestep. The vector stores the following quantities: + +1 = boost factor on this step (unitless) +2 = max strain Eij of any bond on this step (unitless) +3 = ID of first atom in the max-strain bond +4 = ID of second atom in the max-strain bond +5 = average # of bonds/atom on this step :ul + +6 = fraction of timesteps with bias = 0.0 during this run +7 = max drift distance of any atom during this run (distance units) +8 = max bond length during this run (distance units) :ul + +9 = cummulative hyper time since fix was defined (time units) +10 = cummulative count of event timesteps since fix was defined +11 = cummulative count of atoms in events since fix was defined :ul + +The first 5 quantities are for the current timestep. Quantities 6-8 +are for the current hyper run. Quantities 9-11 are cummulative across +multiple runs (since the fix was defined in the input script). + +For value 7, drift is the distance an atom moves between timesteps +when the bond list is reset, i.e. between events. Atoms involved in +an event will typically move the greatest distance since others are +typically oscillating around their lattice site. + +For value 10, events are checked for by the "hyper"_hyper.html command +once every {Nevent} timesteps. This value is the count of those +timesteps on which one (or more) events was detected. It is NOT the +number of distinct events, since more than one event may occur in the +same {Nevent} time window. + +For value 11, each time the "hyper"_hyper.html command checks for an +event, it invokes a compute to flag zero or more atoms as +participating in one or more events. E.g. atoms that have displaced +more than some distance from the previous quench state. Value 11 is +the cummulative count of the number of atoms participating in any of +the events that were found. + +The scalar and vector values calculated by this fix are all +"intensive". + +No parameter of this fix can be used with the {start/stop} keywords of +the "run"_run.html command. This fix is not invoked during "energy +minimization"_minimize.html. + +[Restrictions:] + +This command can only be used if LAMMPS was built with the REPLICA +package. See the "Build package"_Build_package.html doc page for more +info. + +[Related commands:] + +"hyper"_hyper.html, "fix hyper/local"_fix_hyper_local.html + +[Default:] None + +:line + +:link(Voter2013ghd) +[(Voter2013)] S. Y. Kim, D. Perez, A. F. Voter, J Chem Phys, 139, +144110 (2013). + +:link(Mironghd) +[(Miron)] R. A. Miron and K. A. Fichthorn, J Chem Phys, 119, 6210 (2003). diff --git a/doc/src/fix_hyper_local.txt b/doc/src/fix_hyper_local.txt new file mode 100644 index 0000000000000000000000000000000000000000..4af6ab5a55050eb98f33d2d37a1231b2c417eecd --- /dev/null +++ b/doc/src/fix_hyper_local.txt @@ -0,0 +1,404 @@ +"LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c + +:link(lws,http://lammps.sandia.gov) +:link(ld,Manual.html) +:link(lc,Section_commands.html#comm) + +:line + +fix hyper/local command :h3 + +[Syntax:] + +fix ID group-ID hyper/local cutbond qfactor Vmax Tequil Dcut alpha Btarget :pre + +ID, group-ID are documented in "fix"_fix.html command :ulb,l +hyper/local = style name of this fix command :l +cutbond = max distance at which a pair of atoms is considered bonded (distance units) :l +qfactor = max strain at which bias potential goes to 0.0 (unitless) :l +Vmax = estimated height of bias potential (energy units) :l +Tequil = equilibration temperature (temperature units) :l +Dcut = minimum distance between boosted bonds (distance units) :l +alpha = boostostat relaxation time (time units) :l +Btarget = desired time boost factor (unitless) :l +zero or more keyword/value pairs may be appended :l +keyword = {lost} or {check/bias} or {check/coeff} + {lostbond} value = error/warn/ignore + {check/bias} values = Nevery error/warn/ignore + {check/coeff} values = Nevery error/warn/ignore :pre +:ule + +[Examples:] + +fix 1 all hyper/local 1.0 0.3 0.8 300.0 :pre + +[Description:] + +This fix is meant to be used with the "hyper"_hyper.html command to +perform a bond-boost local hyperdynamics (LHD) simulation. The role +of this fix is to a select multiple pairs of atoms in the system at +each timestep to add a local bias potential to, which will alter the +dynamics of the system in a manner that effectively accelerates time. +This is in contrast to the "fix hyper/global"_fix_hyper_global.html +command, which can be user to perform a global hyperdynamics (GHD) +simulation, by adding a global bias potential to a single pair of +atoms at each timestep. GHD can time accelerate a small simulation +with up to a few 100 atoms. For larger systems, LHD is needed to +achieve good time acceleration. + +For a system that undergoes rare transition events, where one or more +atoms move over an energy barrier to a new potential energy basin, the +effect of the bias potential is to induce more rapid transitions. +This can lead to a dramatic speed-up in the rate at which events +occurs, without altering their relative frequencies, thus leading to +an overall increase in the elapsed real time of the simulation as +compared to running for the same number of timesteps with normal MD. +See the "hyper"_hyper.html doc page for a more general discussion of +hyperdynamics and citations that explain both GHD and LHD. + +The equations and logic used by this fix and described here to perform +LHD follow the description given in "(Voter2013)"_#Voter2013lhd. The +bond-boost form of a bias potential for HD is due to Miron and +Fichthorn as described in "(Miron)"_#Mironlhd. + +To understand this description, you should first read the description +of the GHD algorithm on the "fix hyper/global"_fix_hyper_global.html +doc page. This description of LHD builds on the GHD description. + +The definition of bonds, Eij, and Emax are the same for GHD and LHD. +The formulas for Vij(max) and Fij(max) are also the same except for a +pre-factor Cij, explained below. + +The bias energy Vij applied to a bond IJ with maximum strain is + +Vij(max) = Cij * Vmax * (1 - (Eij/q)^2) for abs(Eij) < qfactor + = 0 otherwise :pre + +The derivative of Vij(max) with respect to the position of each atom +in the IJ bond gives a bias force Fij(max) acting on the bond as + +Fij(max) = - dVij(max)/dEij = 2 Cij Vmax Eij / qfactor^2 for abs(Eij) < qfactor + = 0 otherwise :pre + +which can be decomposed into an equal and opposite force acting on +only the two I,J atoms in the IJ bond. + +The key difference is that in GHD a bias energy and force is added (on +a particular timestep) to only one bond (pair of atoms) in the system, +which is the bond with maximum strain Emax. + +In LHD, a bias energy and force can be added to multiple bonds +separated by the specified {Dcut} distance or more. A bond IJ is +biased if it is the maximum strain bond within its local +"neighborhood", which is defined as the bond IJ plus any neighbor +bonds within a distance {Dcut} from IJ. The "distance" between bond +IJ and bond KL is the minimum distance between any of the IK, IL, JK, +JL pairs of atoms. + +For a large system, multiple bonds will typically meet this +requirement, and thus a bias potential Vij(max) will be applied to +many bonds on the same timestep. + +In LHD, all bonds store a Cij prefactor which appears in the Vij(max) +and Fij(max) equations above. Note that the Cij factor scales the +strength of the bias energy and forces whenever bond IJ is the maximum +strain bond in its neighborhood. + +Cij is initialized to 1.0 when a bond between the I,J atoms is first +defined. The specified {Btarget} factor is then used to adjust the +Cij prefactors for each bond every timestep in the following manner. + +An instantaneous boost factor Bij is computed each timestep +for each bond, as + +Bij = exp(beta * Vkl(max)) :pre + +where Vkl(max) is the bias energy of the maxstrain bond KL within bond +IJ's neighborhood, beta = 1/kTequil, and {Tequil} is the temperature +of the system and an argument to this fix. + +NOTE: To run LHD, the input script must also use the "fix +langevin"_fix_langevin.html command to thermostat the atoms at the +same {Tequil} as specified by this fix, so that the system is running +constant-temperature (NVT) dynamics. LAMMPS does not check that this +is done. + +Note that if IJ = KL, then bond IJ is a biased bond on that timestep, +otherwise it is not. But regardless, the boost factor Bij can be +thought of an estimate of time boost currently being applied within a +local region centered on bond IJ. For LHD, we want this to be the +specified {Btarget} value everywhere in the simulation domain. + +To accomplish this, if Bij < Btarget, the Cij prefactor for bond IJ is +incremented on the current timestep by an amount proportional to the +inverse of the specified {alpha} and the difference (Bij - Btarget). +Conversely if Bij > Btarget, Cij is decremented by the same amount. +This procedure is termed "boostostatting" in +"(Voter2013)"_#Voter2013lhd. It drives all of the individual Cij to +values such that when Vij{max} is applied as a bias to bond IJ, the +resulting boost factor Bij will be close to {Btarget} on average. +Thus the LHD time acceleration factor for the overall system is +effectively {Btarget}. + +Note that in LHD, the boost factor {Btarget} is specified by the user. +This is in contrast to global hyperdynamics (GHD) where the boost +factor varies each timestep and is computed as a function of {Vmax}, +Emax, and {Tequil}; see the "fix hyper/global"_fix_hyper_global.html +doc page for details. + +:line + +Here is additional information on the input parameters for LHD. + +Note that the {cutbond}, {qfactor}, and {Tequil} arguments have the +same meaning as for GHD. The {Vmax} argument is slightly different. +The {Dcut}, {alpha}, and {Btarget} parameters are unique to LHD. + +The {cutbond} argument is the cutoff distance for defining bonds +between pairs of nearby atoms. A pair of I,J atoms in their +equilibrium, minimum-energy configuration, which are separated by a +distance Rij < {cutbond}, are flagged as a bonded pair. Setting +{cubond} to be ~25% larger than the nearest-neighbor distance in a +crystalline lattice is a typical choice for solids, so that bonds +exist only between nearest neighbor pairs. + +The {qfactor} argument is the limiting strain at which the bias +potential goes to 0.0. It is dimensionless, so a value of 0.3 means a +bond distance can be up to 30% larger or 30% smaller than the +equilibrium (quenched) R0ij distance and the two atoms in the bond +could still experience a non-zero bias force. + +If {qfactor} is set too large, then transitions from one energy basin +to another are affected because the bias potential is non-zero at the +transition state (e.g. saddle point). If {qfactor} is set too small +than little boost can be achieved because the Eij strain of some bond in +the system will (nearly) always exceed {qfactor}. A value of 0.3 for +{qfactor} is typically a reasonable value. + +The {Vmax} argument is a fixed prefactor on the bias potential. There +is a also a dynamic prefactor Cij, driven by the choice of {Btarget} +as discussed above. The product of these should be a value less than +the smallest barrier height for an event to occur. Otherwise the +applied bias potential may be large enough (when added to the +interatomic potential) to produce a local energy basin with a maxima +in the center. This can produce artificial energy minima in the same +basin that trap an atom. Or if Cij*{Vmax} is even larger, it may +induce an atom(s) to rapidly transition to another energy basin. Both +cases are "bad dynamics" which violate the assumptions of LHD that +guarantee an accelerated time-accurate trajectory of the system. + +NOTE: It may seem that {Vmax} can be set to any value, and Cij will +compensate to reduce the overall prefactor if necessary. However the +Cij are initialized to 1.0 and the boostostatting procedure typically +operates slowly enough that there can be a time period of bad dynamics +if {Vmax} is set too large. A better strategy is to set {Vmax} to the +smallest barrier height for an event (the same as for GHD), so that +the Cij remain near unity. + +The {Tequil} argument is the temperature at which the system is +simulated; see the comment above about the "fix +langevin"_fix_langevin.html thermostatting. It is also part of the +beta term in the exponential factor that determines how much boost is +achieved as a function of the bias potential. See the discussion of +the {Btarget} argument below. + +As discussed above, the {Dcut} argument is the distance required +between two locally maxstrain bonds for them to both be selected as +biased bonds on the same timestep. Computationally, the larger {Dcut} +is, the more work (computation and communication) must be done each +timestep within the LHD algorithm. And the fewer bonds can be +simultaneously biased, which may mean the specified {Btarget} time +acceleration cannot be achieved. + +Physically {Dcut} should be a long enough distance that biasing two +pairs of atoms that close together will not influence the dynamics of +each pair. E.g. something like 2x the cutoff of the interatomic +potential. In practice a {Dcut} value of ~10 Angstroms seems to work +well for many solid-state systems. + +NOTE: You must also insure that ghost atom communication is performed +for a distance of at least {Dcut} + {cutevent} where {cutevent} = the +distance one or more atoms move (between quenched states) to be +considered an "event". It is an argument to the "compute +event/displace" command used to detect events. By default the ghost +communication distance is set by the pair_style cutoff, which will +typically be < {Dcut}. The "comm_modify cutoff"_comm_modify.html +command can be used to set the ghost cutoff explicitly, e.g. + +comm_modify cutoff 12.0 :pre + +This fix does not know the {cutevent} parameter, but uses half the +bond length as an estimate to warn if the ghost cutoff is not long +enough. + +As described above the {alpha} argument is a pre-factor in the +boostostat update equation for each bond's Cij prefactor. {Alpha} is +specified in time units, similar to other thermostat or barostat +damping parameters. It is roughly the physical time it will take the +boostostat to adjust a Cij value from a too high (or too low) value to +a correct one. An {alpha} setting of a few ps is typically good for +solid-state systems. Note that the {alpha} argument here is the +inverse of the alpha parameter discussed in +"(Voter2013)"_#Voter2013lhd. + +The {Btarget} argument is the desired time boost factor (a value > 1) +that all the atoms in the system will experience. The elapsed time +t_hyper for an LHD simulation running for {N} timesteps is simply + +t_hyper = Btarget * N*dt :pre + +where dt is the timestep size defined by the "timestep"_timestep.html +command. The effective time acceleration due to LHD is thus t_hyper / +N*dt = Btarget, where N*dt is elapsed time for a normal MD run +of N timesteps. + +You cannot choose an arbitrarily large setting for {Btarget}. The +maximum value you should choose is + +Btarget = exp(beta * Vsmall) :pre + +where Vsmall is the smallest event barrier height in your system, beta += 1/kTequil, and {Tequil} is the specified temperature of the system +(both by this fix and the Langevin thermostat). + +Note that if {Btarget} is set smaller than this, the LHD simulation +will run correctly. There will just be fewer events because the hyper +time (t_hyper equation above) will be shorter. + +NOTE: If you have no physical intuition as to the smallest barrier +height in your system, a reasonable strategy to determine the largest +{Btarget} you can use for an LHD model, is to run a sequence of +simulations with smaller and smaller {Btarget} values, until the event +rate does not change. + +: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 energy of the bias potential to the the system's +potential energy as part of "thermodynamic output"_thermo_style.html. + +This fix computes a global scalar and global vector of length 23, +which can be accessed by various "output +commands"_Howto_output.html. The scalar is the magnitude of +the bias potential (energy units) applied on the current timestep, +summed over all biased bonds. The vector stores the following +quantities: + +1 = # of biased bonds on this step +2 = max strain Eij of any bond on this step (unitless) +3 = average bias potential for all biased bonds on this step (energy units) +4 = average # of bonds/atom on this step +5 = average neighbor bonds/bond on this step within {Dcut} :ul + +6 = fraction of steps and bonds with no bias during this run +7 = max drift distance of any atom during this run (distance units) +8 = max bond length during this run (distance units) +9 = average # of biased bonds/step during this run +10 = average bias potential for all biased bonds during this run (energy units) +11 = max bias potential for any biased bond during this run (energy units) +12 = min bias potential for any biased bond during this run (energy units) +13 = max distance from my sub-box of any ghost atom with maxstrain < qfactor during this run (distance units) +14 = max distance outside my box of any ghost atom with any maxstrain during this run (distance units) +15 = count of ghost neighbor atoms not found on reneighbor steps during this run +16 = count of lost bond partners during this run +17 = average bias coeff for lost bond partners during this run +18 = count of bias overlaps found during this run +19 = count of non-matching bias coefficients found during this run :ul + +20 = cummulative hyper time since fix created (time units) +21 = cummulative count of event timesteps since fix created +22 = cummulative count of atoms in events since fix created +23 = cummulative # of new bonds since fix created :ul + +The first quantities (1-5) are for the current timestep. Quantities +6-19 are for the current hyper run. They are reset each time a new +hyper run is performed. Quantities 20-23 are cummulative across +multiple runs (since the fix was defined in the input script). + +For value 6, the numerator is a count of all biased bonds on every +timestep whose bias energy = 0.0 due to Eij >= {qfactor}. The +denominator is the count of all biased bonds on all timesteps. + +For value 7, drift is the distance an atom moves between timesteps +when the bond list is reset, i.e. between events. Atoms involved in +an event will typically move the greatest distance since others are +typically oscillating around their lattice site. + +For values 13 and 14, the maxstrain of a ghost atom is the maxstrain +of any bond it is part of, and it is checked for ghost atoms within +the bond neighbor cutoff. + +Values 15-19 are mostly useful for debugging and diagnositc purposes. + +For values 15-17, it is possible that a ghost atom owned by another +processor will move far enough (e.g. as part of an event-in-progress) +that it will no longer be within the communication cutoff distance for +acquiring ghost atoms. Likewise it may be a ghost atom bond partner +that cannot be found because it has moved too far. These values count +those occurrences. Because they typically involve atoms that are part +of events, they do not usually indicate bad dynamics. Value 16 is the +average bias coefficient for bonds where a partner atom was lost. + +For value 18, no two bonds should be biased if they are within a +{Dcut} distance of each other. This value should be zero, indicating +that no pair of bonds "overlap", meaning they are closer than {Dcut} +from each other. + +For value 19, the same bias coefficient is stored by both atoms in an +IJ bond. This value should be zero, indicating that for all bonds, +each atom in the bond stores the a bias coefficient with the same +value. + +Value 20 is simply the specified {boost} factor times the number of +timestep times the timestep size. + +For value 21, events are checked for by the "hyper"_hyper.html command +once every {Nevent} timesteps. This value is the count of those +timesteps on which one (or more) events was detected. It is NOT the +number of distinct events, since more than one event may occur in the +same {Nevent} time window. + +For value 22, each time the "hyper"_hyper.html command checks for an +event, it invokes a compute to flag zero or more atoms as +participating in one or more events. E.g. atoms that have displaced +more than some distance from the previous quench state. Value 22 is +the cummulative count of the number of atoms participating in any of +the events that were found. + +Value 23 tallies the number of new bonds created by the bond reset +operation. Bonds between a specific I,J pair of atoms may persist for +the entire hyperdynamics simulation if neither I or J are involved in +an event. + +The scalar and vector values calculated by this fix are all +"intensive". + +No parameter of this fix can be used with the {start/stop} keywords of +the "run"_run.html command. This fix is not invoked during "energy +minimization"_minimize.html. + +[Restrictions:] + +This fix is part of the REPLICA 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:] + +"hyper"_hyper.html, "fix hyper/global"_fix_hyper_global.html + +[Default:] None + +:line + +:link(Voter2013lhd) +[(Voter2013)] S. Y. Kim, D. Perez, A. F. Voter, J Chem Phys, 139, +144110 (2013). + +:link(Mironlhd) +[(Miron)] R. A. Miron and K. A. Fichthorn, J Chem Phys, 119, 6210 (2003). diff --git a/doc/src/fixes.txt b/doc/src/fixes.txt index 36ccd4f1675f5aca87ecd09b0e3cf68d44746693..eb52583dce95e217be8c397a261c8620757590a6 100644 --- a/doc/src/fixes.txt +++ b/doc/src/fixes.txt @@ -57,6 +57,8 @@ Fixes :h1 fix_grem fix_halt fix_heat + fix_hyper_global + fix_hyper_local fix_imd fix_indent fix_ipi diff --git a/doc/src/hyper.txt b/doc/src/hyper.txt new file mode 100644 index 0000000000000000000000000000000000000000..0ea4ac781b8138b74ee3cded25994307c26a30a8 --- /dev/null +++ b/doc/src/hyper.txt @@ -0,0 +1,192 @@ +"LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c + +:link(lws,http://lammps.sandia.gov) +:link(ld,Manual.html) +:link(lc,Section_commands.html#comm) + +:line + +hyper command :h3 + +[Syntax:] + +hyper N Nevent fix-ID compute-ID keyword values ... :pre + +N = # of timesteps to run :ulb,l +Nevent = check for events every this many steps :l +fix-ID = ID of a fix that applies a global or local bias potential, can be NULL :l +compute-ID = ID of a compute that identifies when an event has occurred :l +zero or more keyword/value pairs may be appended :l +keyword = {min} or {dump} or {rebond} :l + {min} values = etol ftol maxiter maxeval + etol = stopping tolerance for energy, used in quenching + ftol = stopping tolerance for force, used in quenching + maxiter = max iterations of minimize, used in quenching + maxeval = max number of force/energy evaluations, used in quenching + {dump} value = dump-ID + dump-ID = ID of dump to trigger whenever an event takes place + {rebond} value = Nrebond + Nrebond = frequency at which to reset bonds, even if no event has occurred + :pre +:ule + +[Examples:] + +compute event all event/displace 1.0 +fix HG mobile hyper/global 3.0 0.3 0.4 800.0 +hyper 5000 100 HG event min 1.0e-6 1.0e-6 100 100 dump 1 dump 5 :pre + +[Description:] + +Run a bond-boost hyperdynamics (HD) simulation where time is +accelerated by application of a bias potential to one or more pairs of +nearby atoms in the system. This command can be used to run both +global and local hyperdyamics. In global HD a single bond within the +system is biased on each timestep. In local HD multiple bonds +(separated by a sufficient distance) can be biased simultaneously at +each timestep. In the bond-boost hyperdynamics context, a "bond" is +not a covalent bond between a pair of atoms in a molecule. Rather it +is simply a pair of nearby atoms as discussed below. + +Both global and local HD are described in "(Voter2013)"_#Voter2013 by +Art Voter and collaborators. Similar to parallel replica dynamics +(PRD), global and local HD are methods for performing accelerated +dynamics that are suitable for infrequent-event systems that obey +first-order kinetics. A good overview of accelerated dynamics methods +for such systems in given in "(Voter2002)"_#Voter2002hd from the same +group. To quote from the review paper: "The dynamical evolution is +characterized by vibrational excursions within a potential basin, +punctuated by occasional transitions between basins." The transition +probability is characterized by p(t) = k*exp(-kt) where k is the rate +constant. Running multiple replicas gives an effective enhancement in +the timescale spanned by the multiple simulations, while waiting for +an event to occur. + +Both HD and PRD produce a time-accurate trajectory that effectively +extends the timescale over which a system can be simulated, but they +do it differently. HD uses a single replica of the system and +accelerates time by biasing the interaction potential in a manner such +that each timestep is effectively longer. PRD creates Nr replicas of +the system and runs dynamics on each independently with a normal +unbiased potential until an event occurs in one of the replicas. The +time between events is reduced by a factor of Nr replicas. For both +methods, per CPU second, more physical time elapses and more events +occur. See the "prd"_prd.html doc page for more info about PRD. + +An HD run has several stages, which are repeated each time an event +occurs, as explained below. The logic for an HD run is as follows: + +quench +create initial list of bonds :pre + +while (time remains): + run dynamics for Nevent steps + quench + check for an event + if event occurred: reset list of bonds + restore pre-quench state :pre + +The list of bonds is the list of atom pairs of atoms that are within a +short cutoff distance of each other after the system energy is +minimized (quenched). This list is created and reset by a "fix +hyper/global"_fix_hyper_global.html or "fix +hyper/local"_fix_hyper_local.html command specified as {fix-ID}. At +every dynamics timestep, the same fix selects one of more bonds to +apply a bias potential to. + +IMPORTANT NOTE: The style of fix associated with the specified +{fix-ID} determines whether you are running the global versus local +hyperdynamics algorithm. + +Dynamics (with the bias potential) is run continuously, stopping every +{Nevent} steps to check if a transition event has occurred. The +specified {N} for total steps must be a multiple of {Nevent}. check +is performed by quenching the system and comparing the resulting atom +coordinates to the coordinates from the previous basin. + +A quench is an energy minimization and is performed by whichever +algorithm has been defined by the "min_style"_min_style.html command. +Minimization parameters may be set via the +"min_modify"_min_modify.html command and by the {min} keyword of the +hyper command. The latter are the settings that would be used with +the "minimize"_minimize.html command. Note that typically, you do not +need to perform a highly-converged minimization to detect a transition +event, though you may need to in order to prevent a set of atoms in +the system from relaxing to a saddle point. + +The event check is performed by a compute with the specified +{compute-ID}. Currently there is only one compute that works with the +hyper command, which is the "compute +event/displace"_compute_event_displace.html command. Other +event-checking computes may be added. "Compute +event/displace"_compute_event_displace.html checks whether any atom in +the compute group has moved further than a specified threshold +distance. If so, an event has occurred. + +If this happens, the list of bonds is reset, since some bond pairs +are likely now too far apart, and new pairs are likely close enough +to be considered a bond. The pre-quenched state of the +system (coordinates and velocities) is restored, and dynamics continue. + +At the end of the hyper run, a variety of statistics are output to the +screen and logfile. These include info relevant to both global and +local hyperdynamics, such as the number of events and the elapsed +hyper time (acclerated time), And it includes info specific to one or +the other, depending on which style of fix was specified by {fix-ID}. + +:line + +The optional keywords operate as follows. + +As explained above, the {min} keyword can be used to specify +parameters for the quench. Their meaning is the same +as for the "minimize"_minimize.html command + +The {dump} keyword can be used to trigger a specific dump command with +the specified {dump-ID} to output a snapshot each time an event is +detected. It can be specified multiple times with different {dump-ID} +values, as in the example above. These snapshots will be for the +quenched state of the system on a timestep that is a multiple of +{Nevent}, i.e. a timestep after the event has occurred. Note that any +dump command in the input script will also output snapshots at +whatever timestep interval it defines via its {N} argument; see the +"dump"_dump.html command for details. This means if you only want a +particular dump to output snapshots when events are detected, you +should specify its {N} as a value larger than the length of the +hyperdynamics run. + +As in the code logic above, the bond list is normally only reset when +an event occurs. The {rebond} keyword will force a reset of the bond +list every {Nrebond} steps, even if an event has not occurred. +{Nrebond} must be a multiple of {Nevent}. This can be useful to check +if more frequent resets alter event statistics, perhaps because the +parameters chosen for defining what is a bond and what is an event are +producing bad dynamics in the presence of the bias potential. + +:line + +[Restrictions:] + +This command can only be used if LAMMPS was built with the REPLICA +package. See the "Build package"_Build_package.html doc +page for more info. + +[Related commands:] + +"fix hyper/global"_fix_hyper_global.html, "fix +hyper/local"_fix_hyper_local.html, "compute +event/displace"_compute_event_displace.html, "prd"_prd.html + +[Default:] + +The option defaults are min = 0.1 0.1 40 50 and time = steps. + +:line + +:link(Voter2013) +[(Voter2013)] S. Y. Kim, D. Perez, A. F. Voter, J Chem Phys, 139, +144110 (2013). + +:link(Voter2002hd) +[(Voter2002)] Voter, Montalenti, Germann, Annual Review of Materials +Research 32, 321 (2002). diff --git a/doc/src/lammps.book b/doc/src/lammps.book index 419789b2a29fcaf0a6d3c3df2f1855b40c94d13a..3ec314e09e30e71da020a7b717c1a8cf3091a259 100644 --- a/doc/src/lammps.book +++ b/doc/src/lammps.book @@ -160,6 +160,7 @@ dump_cfg_uef.html echo.html group.html group2ndx.html +hyper.html if.html include.html info.html @@ -277,6 +278,8 @@ fix_gravity.html fix_grem.html fix_halt.html fix_heat.html +fix_hyper_global.html +fix_hyper_local.html fix_imd.html fix_indent.html fix_ipi.html diff --git a/doc/src/prd.txt b/doc/src/prd.txt index f71f285336ff716db8af3da6f05b232932629ae2..e1d6fc1b4ef83b727e1c6941b9ecd7cf1e8cd0fb 100644 --- a/doc/src/prd.txt +++ b/doc/src/prd.txt @@ -48,11 +48,12 @@ replicas of a system. One or more replicas can be used. The total number of steps {N} to run can be interpreted in one of two ways; see discussion of the {time} keyword below. -PRD is described in "this paper"_#Voter1998 by Art Voter. It is a method -for performing accelerated dynamics that is suitable for -infrequent-event systems that obey first-order kinetics. A good -overview of accelerated dynamics methods for such systems in given in -"this review paper"_#Voter2002prd from the same group. To quote from the +PRD is described in "(Voter1998)"_#Voter1998 by Art Voter. Similar to +global or local hyperdynamics (HD), PRD is a method for performing +accelerated dynamics that is suitable for infrequent-event systems +that obey first-order kinetics. A good overview of accelerated +dynamics methods for such systems in given in this review paper +"(Voter2002)"_#Voter2002prd from Art's group. To quote from the paper: "The dynamical evolution is characterized by vibrational excursions within a potential basin, punctuated by occasional transitions between basins." The transition probability is @@ -61,15 +62,26 @@ Running multiple replicas gives an effective enhancement in the timescale spanned by the multiple simulations, while waiting for an event to occur. -Each replica runs on a partition of one or more processors. Processor -partitions are defined at run-time using the "-partition command-line -switch"_Run_options.html. Note that if you have MPI installed, you -can run a multi-replica simulation with more replicas (partitions) -than you have physical processors, e.g you can run a 10-replica -simulation on one or two processors. However for PRD, this makes -little sense, since running a replica on virtual instead of physical -processors,offers no effective parallel speed-up in searching for -infrequent events. See the "Howto replica"_Howto_replica.html doc +Both PRD and HD produce a time-accurate trajectory that effectively +extends the timescale over which a system can be simulated, but they +do it differently. PRD creates Nr replicas of the system and runs +dynamics on each independently with a normal unbiased potential until +an event occurs in one of the replicas. The time between events is +reduced by a factor of Nr replicas. HD uses a single replica of the +system and accelerates time by biasing the interaction potential in a +manner such that each timestep is effectively longer. For both +methods, per CPU second, more physical time elapses and more events +occur. See the "hyper"_hyper.html doc page for more info about HD. + +In PRD, each replica runs on a partition of one or more processors. +Processor partitions are defined at run-time using the "-partition +command-line switch"_Run_options.html. Note that if you have MPI +installed, you can run a multi-replica simulation with more replicas +(partitions) than you have physical processors, e.g you can run a +10-replica simulation on one or two processors. However for PRD, this +makes little sense, since running a replica on virtual instead of +physical processors,offers no effective parallel speed-up in searching +for infrequent events. See the "Howto replica"_Howto_replica.html doc page for further discussion. When a PRD simulation is performed, it is assumed that each replica is @@ -78,8 +90,8 @@ I.e. the simulation domain, the number of atoms, the interaction potentials, etc should be the same for every replica. A PRD run has several stages, which are repeated each time an "event" -occurs in one of the replicas, as defined below. The logic for a PRD -run is as follows: +occurs in one of the replicas, as explained below. The logic for a +PRD run is as follows: while (time remains): dephase for n_dephase*t_dephase steps @@ -129,7 +141,8 @@ Minimization parameters may be set via the PRD command. The latter are the settings that would be used with the "minimize"_minimize.html command. Note that typically, you do not need to perform a highly-converged minimization to detect a transition -event. +event, though you may need to in order to prevent a set of atoms in +the system from relaxing to a saddle point. The event check is performed by a compute with the specified {compute-ID}. Currently there is only one compute that works with the @@ -307,7 +320,7 @@ deposit"_fix_deposit.html. "min_modify"_min_modify.html, "min_style"_min_style.html, "run_style"_run_style.html, "minimize"_minimize.html, "velocity"_velocity.html, "temper"_temper.html, "neb"_neb.html, -"tad"_tad.html +"tad"_tad.html, "hyper"_hyper.html [Default:] diff --git a/examples/README b/examples/README index 3c9c299819db13b27f3152cc8496e9ed2f90aaa1..e03dacec82cb55282b34d72782e9a719471a440b 100644 --- a/examples/README +++ b/examples/README @@ -78,6 +78,7 @@ friction: frictional contact of spherical asperities between 2d surfaces gcmc: Grand Canonical Monte Carlo (GCMC) via the fix gcmc command granregion: use of fix wall/region/gran as boundary on granular particles hugoniostat: Hugoniostat shock dynamics +hyper: global and local hyperdynamics of diffusion on Pt surface indent: spherical indenter into a 2d solid kim: use of potentials in Knowledge Base for Interatomic Models (KIM) latte: use of LATTE density-functional tight-binding quantum code diff --git a/examples/hyper/adatoms.list.37K b/examples/hyper/adatoms.list.37K new file mode 100644 index 0000000000000000000000000000000000000000..520570186c6a5174942bbec57670c18cd5c2689e --- /dev/null +++ b/examples/hyper/adatoms.list.37K @@ -0,0 +1,184 @@ +create_atoms 1 single 27.5 9.5 4 +create_atoms 1 single 16 9 4 +create_atoms 1 single 10 12 4 +create_atoms 1 single 31 44 4 +create_atoms 1 single 13 17 4 +create_atoms 1 single 8.5 28.5 4 +create_atoms 1 single 23 26 4 +create_atoms 1 single 38 27 4 +create_atoms 1 single 37.5 4.5 4 +create_atoms 1 single 41.5 47.5 4 +create_atoms 1 single 20.5 37.5 4 +create_atoms 1 single 5 8 4 +create_atoms 1 single 2.5 16.5 4 +create_atoms 1 single 38.5 45.5 4 +create_atoms 1 single 9 0 4 +create_atoms 1 single 39 32 4 +create_atoms 1 single 45.5 11.5 4 +create_atoms 1 single 40 0 4 +create_atoms 1 single 44.5 2.5 4 +create_atoms 1 single 4.5 44.5 4 +create_atoms 1 single 24.5 13.5 4 +create_atoms 1 single 47.5 23.5 4 +create_atoms 1 single 1 20 4 +create_atoms 1 single 38.5 31.5 4 +create_atoms 1 single 12.5 12.5 4 +create_atoms 1 single 2 27 4 +create_atoms 1 single 21 5 4 +create_atoms 1 single 47 12 4 +create_atoms 1 single 32.5 46.5 4 +create_atoms 1 single 9.5 40.5 4 +create_atoms 1 single 8.5 2.5 4 +create_atoms 1 single 41.5 22.5 4 +create_atoms 1 single 29 11 4 +create_atoms 1 single 3.5 3.5 4 +create_atoms 1 single 5 21 4 +create_atoms 1 single 46.5 31.5 4 +create_atoms 1 single 35 46 4 +create_atoms 1 single 40.5 41.5 4 +create_atoms 1 single 10 22 4 +create_atoms 1 single 43.5 14.5 4 +create_atoms 1 single 42 42 4 +create_atoms 1 single 4 26 4 +create_atoms 1 single 19 34 4 +create_atoms 1 single 33 9 4 +create_atoms 1 single 0.5 45.5 4 +create_atoms 1 single 30.5 32.5 4 +create_atoms 1 single 25.5 5.5 4 +create_atoms 1 single 47.5 39.5 4 +create_atoms 1 single 15 13 4 +create_atoms 1 single 21 21 4 +create_atoms 1 single 14 28 4 +create_atoms 1 single 9 34 4 +create_atoms 1 single 7 38 4 +create_atoms 1 single 11 35 4 +create_atoms 1 single 20.5 45.5 4 +create_atoms 1 single 30.5 31.5 4 +create_atoms 1 single 32.5 2.5 4 +create_atoms 1 single 21.5 3.5 4 +create_atoms 1 single 23 12 4 +create_atoms 1 single 4.5 33.5 4 +create_atoms 1 single 46 43 4 +create_atoms 1 single 42.5 45.5 4 +create_atoms 1 single 4.5 10.5 4 +create_atoms 1 single 33.5 15.5 4 +create_atoms 1 single 24 5 4 +create_atoms 1 single 13 16 4 +create_atoms 1 single 16.5 23.5 4 +create_atoms 1 single 45.5 28.5 4 +create_atoms 1 single 44.5 5.5 4 +create_atoms 1 single 27.5 46.5 4 +create_atoms 1 single 44.5 12.5 4 +create_atoms 1 single 12 41 4 +create_atoms 1 single 6 4 4 +create_atoms 1 single 31.5 10.5 4 +create_atoms 1 single 1 44 4 +create_atoms 1 single 31 4 4 +create_atoms 1 single 21 33 4 +create_atoms 1 single 3 33 4 +create_atoms 1 single 15 10 4 +create_atoms 1 single 28.5 22.5 4 +create_atoms 1 single 43 1 4 +create_atoms 1 single 3.5 0.5 4 +create_atoms 1 single 41 37 4 +create_atoms 1 single 18.5 43.5 4 +create_atoms 1 single 17 27 4 +create_atoms 1 single 3 5 4 +create_atoms 1 single 18.5 23.5 4 +create_atoms 1 single 31.5 14.5 4 +create_atoms 1 single 41 31 4 +create_atoms 1 single 22 3 4 +create_atoms 1 single 14.5 40.5 4 +create_atoms 1 single 9 38 4 +create_atoms 1 single 36 42 4 +create_atoms 1 single 33 22 4 +create_atoms 1 single 15.5 47.5 4 +create_atoms 1 single 3 0 4 +create_atoms 1 single 25.5 27.5 4 +create_atoms 1 single 2.5 28.5 4 +create_atoms 1 single 29.5 28.5 4 +create_atoms 1 single 44.5 18.5 4 +create_atoms 1 single 26 40 4 +create_atoms 1 single 41 27 4 +create_atoms 1 single 39.5 5.5 4 +create_atoms 1 single 3 38 4 +create_atoms 1 single 35 29 4 +create_atoms 1 single 11 19 4 +create_atoms 1 single 18 1 4 +create_atoms 1 single 39.5 40.5 4 +create_atoms 1 single 46 17 4 +create_atoms 1 single 1.5 23.5 4 +create_atoms 1 single 28.5 23.5 4 +create_atoms 1 single 10 28 4 +create_atoms 1 single 19 47 4 +create_atoms 1 single 10.5 16.5 4 +create_atoms 1 single 38 45 4 +create_atoms 1 single 42.5 41.5 4 +create_atoms 1 single 47.5 42.5 4 +create_atoms 1 single 38 7 4 +create_atoms 1 single 10 44 4 +create_atoms 1 single 29.5 27.5 4 +create_atoms 1 single 45 30 4 +create_atoms 1 single 3 9 4 +create_atoms 1 single 8.5 35.5 4 +create_atoms 1 single 24 44 4 +create_atoms 1 single 47 4 4 +create_atoms 1 single 7.5 8.5 4 +create_atoms 1 single 32.5 41.5 4 +create_atoms 1 single 0.5 34.5 4 +create_atoms 1 single 11 8 4 +create_atoms 1 single 2 40 4 +create_atoms 1 single 25 24 4 +create_atoms 1 single 47.5 6.5 4 +create_atoms 1 single 39.5 28.5 4 +create_atoms 1 single 17 21 4 +create_atoms 1 single 32 43 4 +create_atoms 1 single 16.5 29.5 4 +create_atoms 1 single 34 34 4 +create_atoms 1 single 11.5 3.5 4 +create_atoms 1 single 39 22 4 +create_atoms 1 single 24.5 36.5 4 +create_atoms 1 single 33 31 4 +create_atoms 1 single 35.5 35.5 4 +create_atoms 1 single 14.5 34.5 4 +create_atoms 1 single 34 28 4 +create_atoms 1 single 37 41 4 +create_atoms 1 single 33 46 4 +create_atoms 1 single 27.5 28.5 4 +create_atoms 1 single 40.5 22.5 4 +create_atoms 1 single 27.5 1.5 4 +create_atoms 1 single 12 2 4 +create_atoms 1 single 36 43 4 +create_atoms 1 single 28.5 9.5 4 +create_atoms 1 single 20.5 25.5 4 +create_atoms 1 single 3 3 4 +create_atoms 1 single 38 33 4 +create_atoms 1 single 3 20 4 +create_atoms 1 single 35 11 4 +create_atoms 1 single 5 25 4 +create_atoms 1 single 36.5 6.5 4 +create_atoms 1 single 19.5 24.5 4 +create_atoms 1 single 27 41 4 +create_atoms 1 single 39.5 11.5 4 +create_atoms 1 single 21.5 2.5 4 +create_atoms 1 single 46.5 15.5 4 +create_atoms 1 single 13 24 4 +create_atoms 1 single 11 37 4 +create_atoms 1 single 11.5 31.5 4 +create_atoms 1 single 47 0 4 +create_atoms 1 single 25.5 17.5 4 +create_atoms 1 single 32 11 4 +create_atoms 1 single 8 17 4 +create_atoms 1 single 27.5 12.5 4 +create_atoms 1 single 25 7 4 +create_atoms 1 single 25.5 37.5 4 +create_atoms 1 single 12 15 4 +create_atoms 1 single 1 7 4 +create_atoms 1 single 18.5 47.5 4 +create_atoms 1 single 5 38 4 +create_atoms 1 single 42 19 4 +create_atoms 1 single 30.5 7.5 4 +create_atoms 1 single 42.5 7.5 4 +create_atoms 1 single 26.5 18.5 4 +create_atoms 1 single 18.5 1.5 4 +create_atoms 1 single 41.5 10.5 4 diff --git a/examples/hyper/global.10Oct18.000000.jpg b/examples/hyper/global.10Oct18.000000.jpg new file mode 100644 index 0000000000000000000000000000000000000000..b462983f6a950954a8606f3cf4dfdbcc0ca6ff96 Binary files /dev/null and b/examples/hyper/global.10Oct18.000000.jpg differ diff --git a/examples/hyper/global.10Oct18.003000.jpg b/examples/hyper/global.10Oct18.003000.jpg new file mode 100644 index 0000000000000000000000000000000000000000..ef28d78d78a6bfa8e46804ed1a0d4634a7866ea6 Binary files /dev/null and b/examples/hyper/global.10Oct18.003000.jpg differ diff --git a/examples/hyper/global.10Oct18.038000.jpg b/examples/hyper/global.10Oct18.038000.jpg new file mode 100644 index 0000000000000000000000000000000000000000..444531312b457e21250706e9564de38a3bfde4b2 Binary files /dev/null and b/examples/hyper/global.10Oct18.038000.jpg differ diff --git a/examples/hyper/global.10Oct18.059000.jpg b/examples/hyper/global.10Oct18.059000.jpg new file mode 100644 index 0000000000000000000000000000000000000000..b77a9e3454a3de55e2d4f69843fbd1518082d9ab Binary files /dev/null and b/examples/hyper/global.10Oct18.059000.jpg differ diff --git a/examples/hyper/in.hyper.global b/examples/hyper/in.hyper.global new file mode 100644 index 0000000000000000000000000000000000000000..22b3b4251b56b6509b3bff59247840c9664129ee --- /dev/null +++ b/examples/hyper/in.hyper.global @@ -0,0 +1,95 @@ +# 3d EAM surface for global HD + +# nearest neighbor distance = a * sqrt(2)/2 = 2.77 Angs for Pt with a = 3.92 +# hop event on (100) surface is same distance +# exchange event is 2 atoms moving same distance + +variable Tequil index 500.0 +variable Vmax index 0.5 +variable qfactor index 0.3 +variable cutbond index 3.2 +variable cutevent index 1.1 +variable steps index 100000 +variable nevent index 1000 +variable zoom index 1.8 + +units metal +atom_style atomic +atom_modify map array +boundary p p p + +lattice fcc 3.92 +region box block 0 6 0 6 0 4 +create_box 3 box +create_atoms 1 box + +mass * 1.0 + +change_box all z final -0.1 5.0 boundary p p f +create_atoms 2 single 3.5 3.5 4 + +# define frozen substrate and mobile atoms + +group adatom type 2 +region base block INF INF INF INF 0 1.8 +set region base type 3 +group base type 3 +group mobile type 1 2 + +# pair style + +pair_style eam/alloy +pair_coeff * * ptvoterlammps.eam Pt Pt Pt + +neighbor 0.5 bin +neigh_modify every 1 delay 5 check yes + +fix 1 mobile nve +fix 2 mobile langevin ${Tequil} ${Tequil} 1.0 858872873 zero yes + +timestep 0.005 + +compute tmobile mobile temp + +thermo 100 +thermo_modify temp tmobile + +# thermal equilibration + +run 1000 +reset_timestep 0 + +# pin base so will not move during quenches + +fix freeze base setforce 0.0 0.0 0.0 + +# event detection + +compute event all event/displace ${cutevent} + +# hyper/global + +fix HG mobile hyper/global ${cutbond} ${qfactor} ${Vmax} ${Tequil} + +# thermo output + +thermo_style custom step temp pe f_HG f_HG[*] + +thermo_modify lost ignore +thermo_modify temp tmobile + +thermo ${nevent} + +# dump output options + +region substrate block INF INF INF INF 1.8 3.8 +region adatoms block INF INF INF INF 3.8 INF +variable acolor atom rmask(base)+2*rmask(substrate)+3*rmask(adatoms) + +dump 1 all image 1000000 global.*.jpg v_acolor type & + zoom ${zoom} adiam 2.5 view 0.0 0.0 up 0 1 0 axes yes 0.9 0.01 +dump_modify 1 pad 6 amap 1 3 sa 1 3 blue red green + +# run + +hyper ${steps} ${nevent} HG event min 1.0e-6 1.0e-6 100 100 dump 1 diff --git a/examples/hyper/in.hyper.local b/examples/hyper/in.hyper.local new file mode 100644 index 0000000000000000000000000000000000000000..ef8ed4d042a5a1516fae9a2d70f8bdc590005473 --- /dev/null +++ b/examples/hyper/in.hyper.local @@ -0,0 +1,112 @@ +# 3d EAM surface for local HD + +# nearest neighbor distance = a * sqrt(2)/2 = 2.77 Angs for Pt with a = 3.92 +# hop event on (100) surface is same distance +# exchange event is 2 atoms moving same distance + +variable Tequil index 400.0 +variable Vmax index 0.4 +variable qfactor index 0.3 +variable cutbond index 3.2 +variable Dcut index 10.0 +variable cutevent index 1.1 +variable alpha index 200.0 +variable boost index 4000.0 +variable ghostcut index 12.0 +variable steps index 1500 +variable nevent index 100 +variable nx index 8 +variable ny index 8 +variable zoom index 1.8 +variable seed index 826626413 +variable tol index 1.0e-15 +variable add index 37K + +units metal +atom_style atomic +atom_modify map array +boundary p p p +comm_modify cutoff ${ghostcut} + +lattice fcc 3.92 +region box block 0 6 0 6 0 4 +create_box 2 box +create_atoms 1 box + +mass * 1.0 + +change_box all z final -0.1 5.0 boundary p p f + +# replicate in xy + +replicate ${nx} ${ny} 1 + +# add adatoms + +include adatoms.list.${add} + +# define frozen substrate and mobile atoms + +region base block INF INF INF INF 0 1.8 +set region base type 2 +group base type 2 +group mobile type 1 + +# pair style + +pair_style eam/alloy +pair_coeff * * ptvoterlammps.eam Pt Pt + +neighbor 0.5 bin +neigh_modify every 1 delay 5 check yes + +fix 1 mobile nve +fix 2 mobile langevin ${Tequil} ${Tequil} 1.0 ${seed} zero yes + +timestep 0.005 + +compute tmobile mobile temp + +thermo 100 +thermo_modify temp tmobile + +# thermal equilibration + +run 1000 +reset_timestep 0 + +# pin base so will not move during quenches + +fix freeze base setforce 0.0 0.0 0.0 + +# event detection + +compute event all event/displace ${cutevent} + +# hyper/local + +fix HL mobile hyper/local ${cutbond} ${qfactor} ${Vmax} ${Tequil} & + ${Dcut} ${alpha} ${boost} + +# thermo output + +thermo_style custom step temp pe f_HL f_HL[*] + +thermo_modify lost ignore +thermo_modify temp tmobile + +thermo ${nevent} + +# dump + +region substrate block INF INF INF INF 1.8 3.8 +region adatoms block INF INF INF INF 3.8 INF +variable acolor atom rmask(base)+2*rmask(substrate)+3*rmask(adatoms) + +dump 1 all image 10000000 local.*.jpg v_acolor type size 1024 1024 & + zoom ${zoom} adiam 2.5 view 0.0 0.0 up 0 1 0 axes yes 0.9 0.01 +dump_modify 1 pad 6 amap 1 3 sa 1 3 blue red green + +# run + +hyper ${steps} ${nevent} HL event min ${tol} ${tol} 1000 1000 dump 1 diff --git a/examples/hyper/local.10Oct18.000000.jpg b/examples/hyper/local.10Oct18.000000.jpg new file mode 100644 index 0000000000000000000000000000000000000000..ef0ec0cd59adaf184019cafa7fa00746be5828fb Binary files /dev/null and b/examples/hyper/local.10Oct18.000000.jpg differ diff --git a/examples/hyper/local.10Oct18.000700.jpg b/examples/hyper/local.10Oct18.000700.jpg new file mode 100644 index 0000000000000000000000000000000000000000..e1e61dd6aa242cff2f12d7f2517c630f62631ccf Binary files /dev/null and b/examples/hyper/local.10Oct18.000700.jpg differ diff --git a/examples/hyper/local.10Oct18.000800.jpg b/examples/hyper/local.10Oct18.000800.jpg new file mode 100644 index 0000000000000000000000000000000000000000..a1e2fbc66a0ac986543bdedbaed05b9afd748091 Binary files /dev/null and b/examples/hyper/local.10Oct18.000800.jpg differ diff --git a/examples/hyper/local.10Oct18.001100.jpg b/examples/hyper/local.10Oct18.001100.jpg new file mode 100644 index 0000000000000000000000000000000000000000..dea7fd4eafd214fc055036e6e6f3e80a60189059 Binary files /dev/null and b/examples/hyper/local.10Oct18.001100.jpg differ diff --git a/examples/hyper/log.10Oct18.hyper.global.g++.4 b/examples/hyper/log.10Oct18.hyper.global.g++.4 new file mode 100644 index 0000000000000000000000000000000000000000..de085415838b8c2822abd62abb4ceccff0e316ee --- /dev/null +++ b/examples/hyper/log.10Oct18.hyper.global.g++.4 @@ -0,0 +1,1243 @@ +LAMMPS (10 Oct 2018) +# 3d EAM surface for global HD + +# nearest neighbor distance = a * sqrt(2)/2 = 2.77 Angs for Pt with a = 3.92 +# hop event on (100) surface is same distance +# exchange event is 2 atoms moving same distance + +variable Tequil index 500.0 +variable Vmax index 0.5 +variable qfactor index 0.3 +variable cutbond index 3.2 +variable cutevent index 1.1 +variable steps index 100000 +variable nevent index 1000 +variable zoom index 1.8 + +units metal +atom_style atomic +atom_modify map array +boundary p p p + +lattice fcc 3.92 +Lattice spacing in x,y,z = 3.92 3.92 3.92 +region box block 0 6 0 6 0 4 +create_box 3 box +Created orthogonal box = (0 0 0) to (23.52 23.52 15.68) + 2 by 2 by 1 MPI processor grid +create_atoms 1 box +Created 576 atoms + Time spent = 0.000782013 secs + +mass * 1.0 + +change_box all z final -0.1 5.0 boundary p p f + orthogonal box = (0 0 -0.392) to (23.52 23.52 19.6) +create_atoms 2 single 3.5 3.5 4 +Created 1 atoms + Time spent = 4.69685e-05 secs + +# define frozen substrate and mobile atoms + +group adatom type 2 +1 atoms in group adatom +region base block INF INF INF INF 0 1.8 +set region base type 3 + 288 settings made for type +group base type 3 +288 atoms in group base +group mobile type 1 2 +289 atoms in group mobile + +# pair style + +pair_style eam/alloy +pair_coeff * * ptvoterlammps.eam Pt Pt Pt + +neighbor 0.5 bin +neigh_modify every 1 delay 5 check yes + +fix 1 mobile nve +fix 2 mobile langevin ${Tequil} ${Tequil} 1.0 858872873 zero yes +fix 2 mobile langevin 500.0 ${Tequil} 1.0 858872873 zero yes +fix 2 mobile langevin 500.0 500.0 1.0 858872873 zero yes + +timestep 0.005 + +compute tmobile mobile temp + +thermo 100 +thermo_modify temp tmobile +WARNING: Temperature for thermo pressure is not for group all (../thermo.cpp:488) + +# thermal equilibration + +run 1000 +Neighbor list info ... + update every 1 steps, delay 5 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.07583 + ghost atom cutoff = 6.07583 + binsize = 3.03792, bins = 8 8 7 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair eam/alloy, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d/newton + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.327 | 3.327 | 3.327 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -3213.9136 0 -3213.9136 -51843.125 + 100 211.06271 -3209.3285 0 -3201.4713 -27323.825 + 200 320.80707 -3205.3715 0 -3193.4289 -39370.402 + 300 393.66139 -3202.607 0 -3187.9522 -32163.403 + 400 401.11987 -3200.2795 0 -3185.347 -35961.543 + 500 472.27798 -3200.7267 0 -3183.1452 -33044.974 + 600 485.16253 -3199.818 0 -3181.7569 -34242.615 + 700 464.85129 -3199.865 0 -3182.56 -35327.179 + 800 518.91236 -3199.4098 0 -3180.0923 -32088.2 + 900 502.76061 -3199.3972 0 -3180.681 -36944.263 + 1000 522.64479 -3200.0627 0 -3180.6063 -32801.856 +Loop time of 0.333434 on 4 procs for 1000 steps with 577 atoms + +Performance: 1295.607 ns/day, 0.019 hours/ns, 2999.091 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 | 0.25639 | 0.2636 | 0.2708 | 1.0 | 79.06 +Neigh | 0.017381 | 0.017991 | 0.018988 | 0.4 | 5.40 +Comm | 0.026086 | 0.034315 | 0.042505 | 3.2 | 10.29 +Output | 0.00022078 | 0.00023323 | 0.00026107 | 0.0 | 0.07 +Modify | 0.013295 | 0.013709 | 0.014107 | 0.2 | 4.11 +Other | | 0.003584 | | | 1.07 + +Nlocal: 144.25 ave 149 max 139 min +Histogram: 1 0 0 1 0 0 0 0 1 1 +Nghost: 530.5 ave 536 max 526 min +Histogram: 1 1 0 0 0 0 0 1 0 1 +Neighs: 3471.75 ave 3626 max 3292 min +Histogram: 1 0 0 0 1 0 1 0 0 1 + +Total # of neighbors = 13887 +Ave neighs/atom = 24.0676 +Neighbor list builds = 88 +Dangerous builds = 0 +reset_timestep 0 + +# pin base so will not move during quenches + +fix freeze base setforce 0.0 0.0 0.0 + +# event detection + +compute event all event/displace ${cutevent} +compute event all event/displace 1.1 + +# hyper/global + +fix HG mobile hyper/global ${cutbond} ${qfactor} ${Vmax} ${Tequil} +fix HG mobile hyper/global 3.2 ${qfactor} ${Vmax} ${Tequil} +fix HG mobile hyper/global 3.2 0.3 ${Vmax} ${Tequil} +fix HG mobile hyper/global 3.2 0.3 0.5 ${Tequil} +fix HG mobile hyper/global 3.2 0.3 0.5 500.0 + +# thermo output + +thermo_style custom step temp pe f_HG f_HG[*] +WARNING: New thermo_style command, previous thermo_modify settings will be lost (../output.cpp:705) + +thermo_modify lost ignore +thermo_modify temp tmobile +WARNING: Temperature for thermo pressure is not for group all (../thermo.cpp:488) + +thermo ${nevent} +thermo 1000 + +# dump output options + +region substrate block INF INF INF INF 1.8 3.8 +region adatoms block INF INF INF INF 3.8 INF +variable acolor atom rmask(base)+2*rmask(substrate)+3*rmask(adatoms) + +dump 1 all image 1000000 global.*.jpg v_acolor type zoom ${zoom} adiam 2.5 view 0.0 0.0 up 0 1 0 axes yes 0.9 0.01 +dump 1 all image 1000000 global.*.jpg v_acolor type zoom 1.8 adiam 2.5 view 0.0 0.0 up 0 1 0 axes yes 0.9 0.01 +dump_modify 1 pad 6 amap 1 3 sa 1 3 blue red green + +# run + +hyper ${steps} ${nevent} HG event min 1.0e-6 1.0e-6 100 100 dump 1 +hyper 100000 ${nevent} HG event min 1.0e-6 1.0e-6 100 100 dump 1 +hyper 100000 1000 HG event min 1.0e-6 1.0e-6 100 100 dump 1 +WARNING: Resetting reneighboring criteria during hyper (../hyper.cpp:133) +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.07583 + ghost atom cutoff = 6.07583 + binsize = 3.03792, bins = 8 8 7 + 2 neighbor lists, perpetual/occasional/extra = 1 1 0 + (1) pair eam/alloy, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d/newton + bin: standard + (2) fix hyper/global, occasional, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 6.015 | 6.015 | 6.015 Mbytes +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 0 522.64479 -3200.0627 0 0 0 0 0 0 0 0 0 0 0 0 + 13 522.64479 -3217.9151 0 0 0 0 0 0 0 0 0 0 0 0 +Loop time of 0.0106812 on 4 procs for 13 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 0 522.64479 -3200.0627 0.39402008 9365.7631 0.13811729 429 426 6.0069324 0 0.36151295 3.1652084 0 0 0 + 1000 512.35059 -3198.5556 0.32845525 2044.9347 0.17572153 257 259 6.0069324 0.137 0.77425934 3.8913771 5302.7599 0 0 +Loop time of 0.314234 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 1000 512.35059 -3198.5556 0.32845525 2044.9347 0.17572153 257 259 6.0069324 0.137 0.77425934 3.8913771 5302.7599 0 0 + 1014 512.35059 -3217.9161 0.32845525 2044.9347 0.17572153 257 259 6.0069324 0.13510848 0.77425934 3.8913771 5302.7599 0 0 +Loop time of 0.0071606 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 1000 512.35059 -3198.5556 0.32845525 2044.9347 0.17572153 257 259 6.0069324 0.137 0.77425934 3.8913771 5302.7599 0 0 + 2000 502.60215 -3197.7892 0.01351505 1.3684394 0.29591771 116 127 6.0069324 0.103 0.77425934 3.8913771 11603.458 0 0 +Loop time of 0.33185 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 2000 502.60215 -3197.7892 0.01351505 1.3684394 0.29591771 116 127 6.0069324 0.103 0.77425934 3.8913771 11603.458 0 0 + 2015 502.60215 -3217.9155 0.01351505 1.3684394 0.29591771 116 127 6.0069324 0.10223325 0.77425934 3.8913771 11603.458 0 0 +Loop time of 0.00889879 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 2000 502.60215 -3197.7892 0.01351505 1.3684394 0.29591771 116 127 6.0069324 0.103 0.77425934 3.8913771 11603.458 0 0 + 3000 481.01481 -3199.1324 0 1 1.0289113 542 544 6.0069324 0.212 2.8308749 5.5814852 12488.613 0 0 +Loop time of 0.334598 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 3000 481.01481 -3199.1324 0 1 1.0289113 542 544 6.0069324 0.212 2.8308749 5.5814852 12488.613 0 0 + 3014 481.01481 -3217.916 0 1 1.0289113 542 544 6.0069324 0.21101526 2.8308749 5.5814852 12488.613 0 0 +Loop time of 0.0103227 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 3000 481.01481 -3199.1324 0.25134819 341.56656 0.21155927 277 539 6.0069324 0.212 2.8308749 5.5814852 12488.613 1 2 + 4000 474.51721 -3197.9082 0.26384891 456.53799 0.20617274 361 83 6.0069324 0.18325 2.8308749 5.5814852 22776.39 1 2 +Loop time of 0.302547 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 4000 474.51721 -3197.9082 0.26384891 456.53799 0.20617274 361 83 6.0069324 0.18325 2.8308749 5.5814852 22776.39 1 2 + 4014 474.51721 -3217.9172 0.26384891 456.53799 0.20617274 361 83 6.0069324 0.18261086 2.8308749 5.5814852 22776.39 1 2 +Loop time of 0.00868511 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 4000 474.51721 -3197.9082 0.26384891 456.53799 0.20617274 361 83 6.0069324 0.18325 2.8308749 5.5814852 22776.39 1 2 + 5000 478.08772 -3199.6792 0.043886568 2.7692147 0.2865317 275 577 6.0069324 0.1586 2.8308749 5.5814852 35085.309 1 2 +Loop time of 0.300419 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 5000 478.08772 -3199.6792 0.043886568 2.7692147 0.2865317 275 577 6.0069324 0.1586 2.8308749 5.5814852 35085.309 1 2 + 5015 478.08772 -3217.9131 0.043886568 2.7692147 0.2865317 275 577 6.0069324 0.15812562 2.8308749 5.5814852 35085.309 1 2 +Loop time of 0.00705171 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 5000 478.08772 -3199.6792 0.043886568 2.7692147 0.2865317 275 577 6.0069324 0.1586 2.8308749 5.5814852 35085.309 1 2 + 6000 458.77612 -3197.8588 0.27710376 620.98321 0.20030308 511 546 6.0069324 0.171 2.8308749 5.5814852 38747.284 1 2 +Loop time of 0.287999 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 6000 458.77612 -3197.8588 0.27710376 620.98321 0.20030308 511 546 6.0069324 0.171 2.8308749 5.5814852 38747.284 1 2 + 6015 458.77612 -3217.9165 0.27710376 620.98321 0.20030308 511 546 6.0069324 0.17057357 2.8308749 5.5814852 38747.284 1 2 +Loop time of 0.00888014 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 6000 458.77612 -3197.8588 0.27710376 620.98321 0.20030308 511 546 6.0069324 0.171 2.8308749 5.5814852 38747.284 1 2 + 7000 476.88452 -3198.3269 0.0828164 6.8352063 0.27403111 264 275 6.0069324 0.17714286 2.8308749 5.5814852 45612.389 1 2 +Loop time of 0.29168 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 7000 476.88452 -3198.3269 0.0828164 6.8352063 0.27403111 264 275 6.0069324 0.17714286 2.8308749 5.5814852 45612.389 1 2 + 7015 476.88452 -3217.9146 0.0828164 6.8352063 0.27403111 264 275 6.0069324 0.17676408 2.8308749 5.5814852 45612.389 1 2 +Loop time of 0.00871038 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 7000 476.88452 -3198.3269 0.0828164 6.8352063 0.27403111 264 275 6.0069324 0.17714286 2.8308749 5.5814852 45612.389 1 2 + 8000 521.60584 -3199.0138 0.22715857 194.82964 0.22161105 419 124 6.0069324 0.191875 2.8308749 5.5814852 46748.053 1 2 +Loop time of 0.284021 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 8000 521.60584 -3199.0138 0.22715857 194.82964 0.22161105 419 124 6.0069324 0.191875 2.8308749 5.5814852 46748.053 1 2 + 8015 521.60584 -3217.9163 0.22715857 194.82964 0.22161105 419 124 6.0069324 0.19151591 2.8308749 5.5814852 46748.053 1 2 +Loop time of 0.00697637 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 8000 521.60584 -3199.0138 0.22715857 194.82964 0.22161105 419 124 6.0069324 0.191875 2.8308749 5.5814852 46748.053 1 2 + 9000 496.87475 -3198.4928 0.13677449 23.912479 0.25569629 264 275 6.0069324 0.18388889 2.8308749 5.5814852 49596.596 1 2 +Loop time of 0.238759 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 9000 496.87475 -3198.4928 0.13677449 23.912479 0.25569629 264 275 6.0069324 0.18388889 2.8308749 5.5814852 49596.596 1 2 + 9014 496.87475 -3217.9149 0.13677449 23.912479 0.25569629 264 275 6.0069324 0.18360328 2.8308749 5.5814852 49596.596 1 2 +Loop time of 0.00677681 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 9000 496.87475 -3198.4928 0.13677449 23.912479 0.25569629 264 275 6.0069324 0.18388889 2.8308749 5.5814852 49596.596 1 2 + 10000 478.6826 -3199.6673 0.37406677 5894.1727 0.1505589 127 132 6.0069324 0.1982 2.8308749 5.5814852 54170.476 1 2 +Loop time of 0.23881 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 10000 478.6826 -3199.6673 0.37406677 5894.1727 0.1505589 127 132 6.0069324 0.1982 2.8308749 5.5814852 54170.476 1 2 + 10013 478.6826 -3217.9144 0.37406677 5894.1727 0.1505589 127 132 6.0069324 0.19794267 2.8308749 5.5814852 54170.476 1 2 +Loop time of 0.00627023 on 4 procs for 13 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 10000 478.6826 -3199.6673 0.37406677 5894.1727 0.1505589 127 132 6.0069324 0.1982 2.8308749 5.5814852 54170.476 1 2 + 11000 518.40222 -3199.3332 0.34753231 3183.9595 0.16566286 383 418 6.0069324 0.18809091 2.8308749 5.5814852 58304.709 1 2 +Loop time of 0.238288 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 11000 518.40222 -3199.3332 0.34753231 3183.9595 0.16566286 383 418 6.0069324 0.18809091 2.8308749 5.5814852 58304.709 1 2 + 11013 518.40222 -3217.915 0.34753231 3183.9595 0.16566286 383 418 6.0069324 0.18786888 2.8308749 5.5814852 58304.709 1 2 +Loop time of 0.00599569 on 4 procs for 13 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 11000 518.40222 -3199.3332 0.34753231 3183.9595 0.16566286 383 418 6.0069324 0.18809091 2.8308749 5.5814852 58304.709 1 2 + 12000 552.07348 -3197.6675 0.0063435549 1.1586177 0.29809086 144 143 6.0069324 0.18016667 2.8308749 5.5814852 66990.451 1 2 +Loop time of 0.23842 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 12000 552.07348 -3197.6675 0.0063435549 1.1586177 0.29809086 144 143 6.0069324 0.18016667 2.8308749 5.5814852 66990.451 1 2 + 12013 552.07348 -3217.9165 0.0063435549 1.1586177 0.29809086 144 143 6.0069324 0.1799717 2.8308749 5.5814852 66990.451 1 2 +Loop time of 0.00602174 on 4 procs for 13 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 12000 552.07348 -3197.6675 0.0063435549 1.1586177 0.29809086 144 143 6.0069324 0.18016667 2.8308749 5.5814852 66990.451 1 2 + 13000 471.13412 -3198.1314 0.30918747 1307.5821 0.18532743 116 123 6.0069324 0.17338462 2.8308749 5.5814852 74345.114 1 2 +Loop time of 0.237671 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 13000 471.13412 -3198.1314 0.30918747 1307.5821 0.18532743 116 123 6.0069324 0.17338462 2.8308749 5.5814852 74345.114 1 2 + 13014 471.13412 -3217.9158 0.30918747 1307.5821 0.18532743 116 123 6.0069324 0.17319809 2.8308749 5.5814852 74345.114 1 2 +Loop time of 0.00647223 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 13000 471.13412 -3198.1314 0.30918747 1307.5821 0.18532743 116 123 6.0069324 0.17338462 2.8308749 5.5814852 74345.114 1 2 + 14000 470.81692 -3198.8871 0.10763953 12.160669 0.26575343 275 577 6.0069324 0.18235714 2.8308749 5.5814852 76252.748 1 2 +Loop time of 0.238789 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 14000 470.81692 -3198.8871 0.10763953 12.160669 0.26575343 275 577 6.0069324 0.18235714 2.8308749 5.5814852 76252.748 1 2 + 14015 470.81692 -3217.9147 0.10763953 12.160669 0.26575343 275 577 6.0069324 0.18216197 2.8308749 5.5814852 76252.748 1 2 +Loop time of 0.00651169 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 14000 470.81692 -3198.8871 0.10763953 12.160669 0.26575343 275 577 6.0069324 0.18235714 2.8308749 5.5814852 76252.748 1 2 + 15000 473.2435 -3199.0907 0.20712247 122.37713 0.22960391 569 570 6.0069324 0.18553333 2.8308749 5.5814852 81659.641 1 2 +Loop time of 0.23755 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 15000 473.2435 -3199.0907 0.20712247 122.37713 0.22960391 569 570 6.0069324 0.18553333 2.8308749 5.5814852 81659.641 1 2 + 15014 473.2435 -3217.9161 0.20712247 122.37713 0.22960391 569 570 6.0069324 0.18536033 2.8308749 5.5814852 81659.641 1 2 +Loop time of 0.00644851 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 15000 473.2435 -3199.0907 0.20712247 122.37713 0.22960391 569 570 6.0069324 0.18553333 2.8308749 5.5814852 81659.641 1 2 + 16000 504.33627 -3199.1713 0.036898146 2.3545967 0.28871843 264 275 6.0069324 0.199875 2.8308749 5.5814852 82224.366 1 2 +Loop time of 0.240195 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 16000 504.33627 -3199.1713 0.036898146 2.3545967 0.28871843 264 275 6.0069324 0.199875 2.8308749 5.5814852 82224.366 1 2 + 16015 504.33627 -3217.9137 0.036898146 2.3545967 0.28871843 264 275 6.0069324 0.19968779 2.8308749 5.5814852 82224.366 1 2 +Loop time of 0.00684911 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 16000 504.33627 -3199.1713 0.036898146 2.3545967 0.28871843 264 275 6.0069324 0.199875 2.8308749 5.5814852 82224.366 1 2 + 17000 497.60607 -3198.212 0.0067178767 1.1687272 0.29797782 264 275 6.0069324 0.217 2.8308749 5.5814852 82242.51 1 2 +Loop time of 0.240567 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 17000 497.60607 -3198.212 0.0067178767 1.1687272 0.29797782 264 275 6.0069324 0.217 2.8308749 5.5814852 82242.51 1 2 + 17016 497.60607 -3217.9161 0.0067178767 1.1687272 0.29797782 264 275 6.0069324 0.21679596 2.8308749 5.5814852 82242.51 1 2 +Loop time of 0.00708336 on 4 procs for 16 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 17000 497.60607 -3198.212 0.0067178767 1.1687272 0.29797782 264 275 6.0069324 0.217 2.8308749 5.5814852 82242.51 1 2 + 18000 523.92168 -3199.831 0.21046671 132.25396 0.22828927 264 275 6.0069324 0.22444444 2.8308749 5.5814852 82304.143 1 2 +Loop time of 0.240636 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 18000 523.92168 -3199.831 0.21046671 132.25396 0.22828927 264 275 6.0069324 0.22444444 2.8308749 5.5814852 82304.143 1 2 + 18014 523.92168 -3217.9153 0.21046671 132.25396 0.22828927 264 275 6.0069324 0.22427001 2.8308749 5.5814852 82304.143 1 2 +Loop time of 0.00646216 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 18000 523.92168 -3199.831 0.21046671 132.25396 0.22828927 264 275 6.0069324 0.22444444 2.8308749 5.5814852 82304.143 1 2 + 19000 538.76557 -3198.7203 0.036295998 2.3219194 0.28890608 397 400 6.0069324 0.228 2.8308749 5.5814852 83487.232 1 2 +Loop time of 0.239259 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 19000 538.76557 -3198.7203 0.036295998 2.3219194 0.28890608 397 400 6.0069324 0.228 2.8308749 5.5814852 83487.232 1 2 + 19014 538.76557 -3217.9141 0.036295998 2.3219194 0.28890608 397 400 6.0069324 0.22783212 2.8308749 5.5814852 83487.232 1 2 +Loop time of 0.0061307 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 19000 538.76557 -3198.7203 0.036295998 2.3219194 0.28890608 397 400 6.0069324 0.228 2.8308749 5.5814852 83487.232 1 2 + 20000 483.9598 -3198.1166 0.13750177 24.319538 0.25544017 400 131 6.0069324 0.2187 2.8308749 5.5814852 91177.618 1 2 +Loop time of 0.241751 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 20000 483.9598 -3198.1166 0.13750177 24.319538 0.25544017 400 131 6.0069324 0.2187 2.8308749 5.5814852 91177.618 1 2 + 20014 483.9598 -3217.9137 0.13750177 24.319538 0.25544017 400 131 6.0069324 0.21854702 2.8308749 5.5814852 91177.618 1 2 +Loop time of 0.00646776 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 20000 483.9598 -3198.1166 0.13750177 24.319538 0.25544017 400 131 6.0069324 0.2187 2.8308749 5.5814852 91177.618 1 2 + 21000 518.44073 -3199.7932 0.30241436 1117.3756 0.18858795 553 577 6.0069324 0.21271429 2.8308749 5.5814852 99740.17 1 2 +Loop time of 0.239403 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 21000 518.44073 -3199.7932 0.30241436 1117.3756 0.18858795 553 577 6.0069324 0.21271429 2.8308749 5.5814852 99740.17 1 2 + 21014 518.44073 -3217.9126 0.30241436 1117.3756 0.18858795 553 577 6.0069324 0.21257257 2.8308749 5.5814852 99740.17 1 2 +Loop time of 0.00643963 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 21000 518.44073 -3199.7932 0.30241436 1117.3756 0.18858795 553 577 6.0069324 0.21271429 2.8308749 5.5814852 99740.17 1 2 + 22000 518.95823 -3198.6693 0 1 0.4887755 262 263 6.0069324 0.22327273 2.8308749 5.5814852 103304.87 1 2 +Loop time of 0.241227 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 22000 518.95823 -3198.6693 0 1 0.4887755 262 263 6.0069324 0.22327273 2.8308749 5.5814852 103304.87 1 2 + 22033 518.95823 -3217.916 0 1 0.4887755 262 263 6.0069324 0.22293832 2.8308749 5.5814852 103304.87 1 2 +Loop time of 0.015579 on 4 procs for 33 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 22000 518.95823 -3198.6693 0 1 0.4887755 262 263 6.0069324 0.22327273 2.8308749 5.5814852 103304.87 1 2 + 23000 534.01428 -3197.6551 0.10264812 10.830446 0.26743848 136 431 6.0069324 0.22469565 2.8308749 5.5814852 108159.84 1 2 +Loop time of 0.240257 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 23000 534.01428 -3197.6551 0.10264812 10.830446 0.26743848 136 431 6.0069324 0.22469565 2.8308749 5.5814852 108159.84 1 2 + 23015 534.01428 -3217.9147 0.10264812 10.830446 0.26743848 136 431 6.0069324 0.22454921 2.8308749 5.5814852 108159.84 1 2 +Loop time of 0.0067718 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 23000 534.01428 -3197.6551 0.10264812 10.830446 0.26743848 136 431 6.0069324 0.22469565 2.8308749 5.5814852 108159.84 1 2 + 24000 502.61915 -3198.9796 0.22019457 165.75289 0.22442143 132 143 6.0069324 0.21883333 2.8308749 5.5814852 115124.63 1 2 +Loop time of 0.241014 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 24000 502.61915 -3198.9796 0.22019457 165.75289 0.22442143 132 143 6.0069324 0.21883333 2.8308749 5.5814852 115124.63 1 2 + 24014 502.61915 -3217.9149 0.22019457 165.75289 0.22442143 132 143 6.0069324 0.21870575 2.8308749 5.5814852 115124.63 1 2 +Loop time of 0.006706 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 24000 502.61915 -3198.9796 0.22019457 165.75289 0.22442143 132 143 6.0069324 0.21883333 2.8308749 5.5814852 115124.63 1 2 + 25000 510.27664 -3200.7431 0.34609419 3079.4414 0.16644232 120 119 6.0069324 0.21512 2.8308749 5.5814852 118042.99 1 2 +Loop time of 0.239452 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 25000 510.27664 -3200.7431 0.34609419 3079.4414 0.16644232 120 119 6.0069324 0.21512 2.8308749 5.5814852 118042.99 1 2 + 25013 510.27664 -3217.9127 0.34609419 3079.4414 0.16644232 120 119 6.0069324 0.2150082 2.8308749 5.5814852 118042.99 1 2 +Loop time of 0.00622821 on 4 procs for 13 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 25000 510.27664 -3200.7431 0.34609419 3079.4414 0.16644232 120 119 6.0069324 0.21512 2.8308749 5.5814852 118042.99 1 2 + 26000 511.79717 -3198.2999 0.19492582 92.206933 0.23433598 263 577 6.0069324 0.21273077 2.8308749 5.5814852 124902.88 1 2 +Loop time of 0.271219 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 26000 511.79717 -3198.2999 0.19492582 92.206933 0.23433598 263 577 6.0069324 0.21273077 2.8308749 5.5814852 124902.88 1 2 + 26015 511.79717 -3217.9147 0.19492582 92.206933 0.23433598 263 577 6.0069324 0.21260811 2.8308749 5.5814852 124902.88 1 2 +Loop time of 0.0105773 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 26000 511.79717 -3198.2999 0.19492582 92.206933 0.23433598 263 577 6.0069324 0.21273077 2.8308749 5.5814852 124902.88 1 2 + 27000 487.73368 -3197.4904 0.19560731 93.67693 0.2340741 401 572 6.0069324 0.20814815 2.8308749 5.5814852 130713.79 1 2 +Loop time of 0.293879 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 27000 487.73368 -3197.4904 0.19560731 93.67693 0.2340741 401 572 6.0069324 0.20814815 2.8308749 5.5814852 130713.79 1 2 + 27015 487.73368 -3217.9161 0.19560731 93.67693 0.2340741 401 572 6.0069324 0.20803257 2.8308749 5.5814852 130713.79 1 2 +Loop time of 0.00895333 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 27000 487.73368 -3197.4904 0.19560731 93.67693 0.2340741 401 572 6.0069324 0.20814815 2.8308749 5.5814852 130713.79 1 2 + 28000 468.95408 -3198.4177 0.3457758 3056.7694 0.1666144 549 515 6.0069324 0.204 2.8308749 5.5814852 135376.2 1 2 +Loop time of 0.286141 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 28000 468.95408 -3198.4177 0.3457758 3056.7694 0.1666144 549 515 6.0069324 0.204 2.8308749 5.5814852 135376.2 1 2 + 28014 468.95408 -3217.9167 0.3457758 3056.7694 0.1666144 549 515 6.0069324 0.20389805 2.8308749 5.5814852 135376.2 1 2 +Loop time of 0.00648469 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 28000 468.95408 -3198.4177 0.3457758 3056.7694 0.1666144 549 515 6.0069324 0.204 2.8308749 5.5814852 135376.2 1 2 + 29000 518.03534 -3198.1622 0.029706116 1.9926184 0.29095171 267 260 6.0069324 0.20031034 2.8308749 5.5814852 143604.35 1 2 +Loop time of 0.24066 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 29000 518.03534 -3198.1622 0.029706116 1.9926184 0.29095171 267 260 6.0069324 0.20031034 2.8308749 5.5814852 143604.35 1 2 + 29014 518.03534 -3217.9137 0.029706116 1.9926184 0.29095171 267 260 6.0069324 0.20021369 2.8308749 5.5814852 143604.35 1 2 +Loop time of 0.0063417 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 29000 518.03534 -3198.1622 0.029706116 1.9926184 0.29095171 267 260 6.0069324 0.20031034 2.8308749 5.5814852 143604.35 1 2 + 30000 535.78782 -3198.3125 0.33831746 2570.9054 0.17059559 122 124 6.0069324 0.19596667 2.8308749 5.5814852 150106.09 1 2 +Loop time of 0.259515 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 30000 535.78782 -3198.3125 0.33831746 2570.9054 0.17059559 122 124 6.0069324 0.19596667 2.8308749 5.5814852 150106.09 1 2 + 30014 535.78782 -3217.9119 0.33831746 2570.9054 0.17059559 122 124 6.0069324 0.19587526 2.8308749 5.5814852 150106.09 1 2 +Loop time of 0.0123347 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 30000 535.78782 -3198.3125 0.33831746 2570.9054 0.17059559 122 124 6.0069324 0.19596667 2.8308749 5.5814852 150106.09 1 2 + 31000 547.06872 -3198.3217 0.21707776 154.18603 0.22566791 275 577 6.0069324 0.19987097 2.8308749 5.5814852 151076.53 1 2 +Loop time of 0.321976 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 31000 547.06872 -3198.3217 0.21707776 154.18603 0.22566791 275 577 6.0069324 0.19987097 2.8308749 5.5814852 151076.53 1 2 + 31014 547.06872 -3217.9165 0.21707776 154.18603 0.22566791 275 577 6.0069324 0.19978074 2.8308749 5.5814852 151076.53 1 2 +Loop time of 0.00811768 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 31000 547.06872 -3198.3217 0.21707776 154.18603 0.22566791 275 577 6.0069324 0.19987097 2.8308749 5.5814852 151076.53 1 2 + 32000 469.53603 -3199.325 0.35776457 4037.4217 0.16000743 563 268 6.0069324 0.20171875 2.8308749 5.5814852 152526.06 1 2 +Loop time of 0.290834 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 32000 469.53603 -3199.325 0.35776457 4037.4217 0.16000743 563 268 6.0069324 0.20171875 2.8308749 5.5814852 152526.06 1 2 + 32013 469.53603 -3217.9147 0.35776457 4037.4217 0.16000743 563 268 6.0069324 0.20163684 2.8308749 5.5814852 152526.06 1 2 +Loop time of 0.00746775 on 4 procs for 13 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 32000 469.53603 -3199.325 0.35776457 4037.4217 0.16000743 563 268 6.0069324 0.20171875 2.8308749 5.5814852 152526.06 1 2 + 33000 491.33889 -3199.1986 0.32620326 1940.7983 0.17687118 258 228 6.0069324 0.19833333 2.8308749 5.5814852 156385.66 1 2 +Loop time of 0.243351 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 33000 491.33889 -3199.1986 0.32620326 1940.7983 0.17687118 258 228 6.0069324 0.19833333 2.8308749 5.5814852 156385.66 1 2 + 33014 491.33889 -3217.9155 0.32620326 1940.7983 0.17687118 258 228 6.0069324 0.19824923 2.8308749 5.5814852 156385.66 1 2 +Loop time of 0.00658584 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 33000 491.33889 -3199.1986 0.32620326 1940.7983 0.17687118 258 228 6.0069324 0.19833333 2.8308749 5.5814852 156385.66 1 2 + 34000 503.19322 -3198.8767 0.050333006 3.2161315 0.28449966 275 577 6.0069324 0.19794118 2.8308749 5.5814852 161964.99 1 2 +Loop time of 0.238415 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 34000 503.19322 -3198.8767 0.050333006 3.2161315 0.28449966 275 577 6.0069324 0.19794118 2.8308749 5.5814852 161964.99 1 2 + 34016 503.19322 -3217.9158 0.050333006 3.2161315 0.28449966 275 577 6.0069324 0.19784807 2.8308749 5.5814852 161964.99 1 2 +Loop time of 0.00771642 on 4 procs for 16 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 34000 503.19322 -3198.8767 0.050333006 3.2161315 0.28449966 275 577 6.0069324 0.19794118 2.8308749 5.5814852 161964.99 1 2 + 35000 513.68037 -3197.8169 0.26004762 417.98593 0.20782548 264 275 6.0069324 0.199 2.8308749 5.5814852 164995.25 1 2 +Loop time of 0.240164 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 35000 513.68037 -3197.8169 0.26004762 417.98593 0.20782548 264 275 6.0069324 0.199 2.8308749 5.5814852 164995.25 1 2 + 35015 513.68037 -3217.9147 0.26004762 417.98593 0.20782548 264 275 6.0069324 0.19891475 2.8308749 5.5814852 164995.25 1 2 +Loop time of 0.00711012 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 35000 513.68037 -3197.8169 0.26004762 417.98593 0.20782548 264 275 6.0069324 0.199 2.8308749 5.5814852 164995.25 1 2 + 36000 508.23462 -3199.0337 0.009260286 1.2397653 0.29720893 563 564 6.0069324 0.20069444 2.8308749 5.5814852 167465.14 1 2 +Loop time of 0.240289 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 36000 508.23462 -3199.0337 0.009260286 1.2397653 0.29720893 563 564 6.0069324 0.20069444 2.8308749 5.5814852 167465.14 1 2 + 36014 508.23462 -3217.9163 0.009260286 1.2397653 0.29720893 563 564 6.0069324 0.20061643 2.8308749 5.5814852 167465.14 1 2 +Loop time of 0.00642586 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 36000 508.23462 -3199.0337 0.009260286 1.2397653 0.29720893 563 564 6.0069324 0.20069444 2.8308749 5.5814852 167465.14 1 2 + 37000 500.95069 -3199.7129 0.024475083 1.764809 0.29256535 275 577 6.0069324 0.19783784 2.8308749 5.5814852 169290.01 1 2 +Loop time of 0.239462 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 37000 500.95069 -3199.7129 0.024475083 1.764809 0.29256535 275 577 6.0069324 0.19783784 2.8308749 5.5814852 169290.01 1 2 + 37015 500.95069 -3217.916 0.024475083 1.764809 0.29256535 275 577 6.0069324 0.19775767 2.8308749 5.5814852 169290.01 1 2 +Loop time of 0.00713468 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 37000 500.95069 -3199.7129 0.024475083 1.764809 0.29256535 275 577 6.0069324 0.19783784 2.8308749 5.5814852 169290.01 1 2 + 38000 495.41803 -3199.6385 0 1 1.0152866 262 275 6.0069324 0.21794737 2.8308749 5.5814852 169297.9 1 2 +Loop time of 0.239667 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 38000 495.41803 -3199.6385 0 1 1.0152866 262 275 6.0069324 0.21794737 2.8308749 5.5814852 169297.9 1 2 + 38013 495.41803 -3217.9157 0 1 1.0152866 262 275 6.0069324 0.21787283 2.8308749 5.5814852 169297.9 1 2 +Loop time of 0.00627661 on 4 procs for 13 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 38000 495.41803 -3199.6385 0.39298625 9143.7129 0.13878932 430 431 6.0069324 0.21794737 2.8308749 5.5814852 169297.9 2 4 + 39000 469.05202 -3196.0515 0.10638057 11.810485 0.26617945 408 415 6.0069324 0.21410256 2.8308749 5.5814852 175842.05 2 4 +Loop time of 0.238329 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 39000 469.05202 -3196.0515 0.10638057 11.810485 0.26617945 408 415 6.0069324 0.21410256 2.8308749 5.5814852 175842.05 2 4 + 39015 469.05202 -3217.917 0.10638057 11.810485 0.26617945 408 415 6.0069324 0.21402025 2.8308749 5.5814852 175842.05 2 4 +Loop time of 0.00683451 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 39000 469.05202 -3196.0515 0.10638057 11.810485 0.26617945 408 415 6.0069324 0.21410256 2.8308749 5.5814852 175842.05 2 4 + 40000 542.78328 -3198.4918 0.18612218 75.166934 0.2376931 567 560 6.0069324 0.214275 2.8308749 5.5814852 179412.45 2 4 +Loop time of 0.23954 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 40000 542.78328 -3198.4918 0.18612218 75.166934 0.2376931 567 560 6.0069324 0.214275 2.8308749 5.5814852 179412.45 2 4 + 40014 542.78328 -3217.9148 0.18612218 75.166934 0.2376931 567 560 6.0069324 0.21420003 2.8308749 5.5814852 179412.45 2 4 +Loop time of 0.00652599 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 40000 542.78328 -3198.4918 0.18612218 75.166934 0.2376931 567 560 6.0069324 0.214275 2.8308749 5.5814852 179412.45 2 4 + 41000 548.99015 -3197.5893 0.30318345 1137.4995 0.18822056 124 135 6.0069324 0.21114634 2.8308749 5.5814852 184564.49 2 4 +Loop time of 0.239863 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 41000 548.99015 -3197.5893 0.30318345 1137.4995 0.18822056 124 135 6.0069324 0.21114634 2.8308749 5.5814852 184564.49 2 4 + 41014 548.99015 -3217.9174 0.30318345 1137.4995 0.18822056 124 135 6.0069324 0.21107427 2.8308749 5.5814852 184564.49 2 4 +Loop time of 0.00668764 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 41000 548.99015 -3197.5893 0.30318345 1137.4995 0.18822056 124 135 6.0069324 0.21114634 2.8308749 5.5814852 184564.49 2 4 + 42000 492.4929 -3198.0535 0.31406773 1464.4003 0.18294209 262 264 6.0069324 0.20954762 2.8308749 5.5814852 187620.86 2 4 +Loop time of 0.238458 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 42000 492.4929 -3198.0535 0.31406773 1464.4003 0.18294209 262 264 6.0069324 0.20954762 2.8308749 5.5814852 187620.86 2 4 + 42014 492.4929 -3217.9154 0.31406773 1464.4003 0.18294209 262 264 6.0069324 0.20947779 2.8308749 5.5814852 187620.86 2 4 +Loop time of 0.00658375 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 42000 492.4929 -3198.0535 0.31406773 1464.4003 0.18294209 262 264 6.0069324 0.20954762 2.8308749 5.5814852 187620.86 2 4 + 43000 524.32334 -3199.9723 0.171134 53.082676 0.24330204 287 276 6.0069324 0.20893023 2.8308749 5.5814852 189618.98 2 4 +Loop time of 0.240476 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 43000 524.32334 -3199.9723 0.171134 53.082676 0.24330204 287 276 6.0069324 0.20893023 2.8308749 5.5814852 189618.98 2 4 + 43015 524.32334 -3217.9151 0.171134 53.082676 0.24330204 287 276 6.0069324 0.20885738 2.8308749 5.5814852 189618.98 2 4 +Loop time of 0.00655174 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 43000 524.32334 -3199.9723 0.171134 53.082676 0.24330204 287 276 6.0069324 0.20893023 2.8308749 5.5814852 189618.98 2 4 + 44000 490.60365 -3198.9839 0.12604882 18.642955 0.25944404 544 276 6.0069324 0.21018182 2.8308749 5.5814852 193452.76 2 4 +Loop time of 0.240179 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 44000 490.60365 -3198.9839 0.12604882 18.642955 0.25944404 544 276 6.0069324 0.21018182 2.8308749 5.5814852 193452.76 2 4 + 44015 490.60365 -3217.9148 0.12604882 18.642955 0.25944404 544 276 6.0069324 0.21011019 2.8308749 5.5814852 193452.76 2 4 +Loop time of 0.00717342 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 44000 490.60365 -3198.9839 0.12604882 18.642955 0.25944404 544 276 6.0069324 0.21018182 2.8308749 5.5814852 193452.76 2 4 + 45000 516.91704 -3198.746 0.30358614 1148.1804 0.18802791 114 120 6.0069324 0.2092 2.8308749 5.5814852 194591.87 2 4 +Loop time of 0.24121 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 45000 516.91704 -3198.746 0.30358614 1148.1804 0.18802791 114 120 6.0069324 0.2092 2.8308749 5.5814852 194591.87 2 4 + 45013 516.91704 -3217.9155 0.30358614 1148.1804 0.18802791 114 120 6.0069324 0.20913958 2.8308749 5.5814852 194591.87 2 4 +Loop time of 0.00649601 on 4 procs for 13 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 45000 516.91704 -3198.746 0.30358614 1148.1804 0.18802791 114 120 6.0069324 0.2092 2.8308749 5.5814852 194591.87 2 4 + 46000 511.1774 -3196.9369 0.25070338 336.49294 0.21183341 138 259 6.0069324 0.20769565 2.8308749 5.5814852 199937.52 2 4 +Loop time of 0.239441 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 46000 511.1774 -3196.9369 0.25070338 336.49294 0.21183341 138 259 6.0069324 0.20769565 2.8308749 5.5814852 199937.52 2 4 + 46015 511.1774 -3217.9159 0.25070338 336.49294 0.21183341 138 259 6.0069324 0.20762795 2.8308749 5.5814852 199937.52 2 4 +Loop time of 0.00681973 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 46000 511.1774 -3196.9369 0.25070338 336.49294 0.21183341 138 259 6.0069324 0.20769565 2.8308749 5.5814852 199937.52 2 4 + 47000 480.5069 -3198.8501 0.071646863 5.2743358 0.27767529 544 556 6.0069324 0.20602128 2.8308749 5.5814852 202107.88 2 4 +Loop time of 0.24022 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 47000 480.5069 -3198.8501 0.071646863 5.2743358 0.27767529 544 556 6.0069324 0.20602128 2.8308749 5.5814852 202107.88 2 4 + 47016 480.5069 -3217.9167 0.071646863 5.2743358 0.27767529 544 556 6.0069324 0.20595117 2.8308749 5.5814852 202107.88 2 4 +Loop time of 0.007438 on 4 procs for 16 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 47000 480.5069 -3198.8501 0.071646863 5.2743358 0.27767529 544 556 6.0069324 0.20602128 2.8308749 5.5814852 202107.88 2 4 + 48000 540.51895 -3198.5792 0.04754734 3.0147795 0.28537953 544 556 6.0069324 0.2085 2.8308749 5.5814852 202899.91 2 4 +Loop time of 0.241529 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 48000 540.51895 -3198.5792 0.04754734 3.0147795 0.28537953 544 556 6.0069324 0.2085 2.8308749 5.5814852 202899.91 2 4 + 48015 540.51895 -3217.9148 0.04754734 3.0147795 0.28537953 544 556 6.0069324 0.20843486 2.8308749 5.5814852 202899.91 2 4 +Loop time of 0.00695753 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 48000 540.51895 -3198.5792 0.04754734 3.0147795 0.28537953 544 556 6.0069324 0.2085 2.8308749 5.5814852 202899.91 2 4 + 49000 527.63013 -3199.0384 0.28400417 728.84104 0.19717822 544 577 6.0069324 0.20961224 2.8308749 5.5814852 210926.93 2 4 +Loop time of 0.241009 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 49000 527.63013 -3199.0384 0.28400417 728.84104 0.19717822 544 577 6.0069324 0.20961224 2.8308749 5.5814852 210926.93 2 4 + 49013 527.63013 -3217.9157 0.28400417 728.84104 0.19717822 544 577 6.0069324 0.20955665 2.8308749 5.5814852 210926.93 2 4 +Loop time of 0.00608408 on 4 procs for 13 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 49000 527.63013 -3199.0384 0.28400417 728.84104 0.19717822 544 577 6.0069324 0.20961224 2.8308749 5.5814852 210926.93 2 4 + 50000 516.69962 -3198.3346 0.35295929 3611.3455 0.16268782 266 243 6.0069324 0.20898 2.8308749 5.5814852 215664.98 2 4 +Loop time of 0.239941 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 50000 516.69962 -3198.3346 0.35295929 3611.3455 0.16268782 266 243 6.0069324 0.20898 2.8308749 5.5814852 215664.98 2 4 + 50013 516.69962 -3217.9156 0.35295929 3611.3455 0.16268782 266 243 6.0069324 0.20892568 2.8308749 5.5814852 215664.98 2 4 +Loop time of 0.00602353 on 4 procs for 13 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 50000 516.69962 -3198.3346 0.35295929 3611.3455 0.16268782 266 243 6.0069324 0.20898 2.8308749 5.5814852 215664.98 2 4 + 51000 533.05598 -3198.0432 0.17474232 57.719563 0.2419636 123 128 6.0069324 0.2065098 2.8308749 5.5814852 221609.1 2 4 +Loop time of 0.240274 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 51000 533.05598 -3198.0432 0.17474232 57.719563 0.2419636 123 128 6.0069324 0.2065098 2.8308749 5.5814852 221609.1 2 4 + 51015 533.05598 -3217.9143 0.17474232 57.719563 0.2419636 123 128 6.0069324 0.20644908 2.8308749 5.5814852 221609.1 2 4 +Loop time of 0.00743866 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 51000 533.05598 -3198.0432 0.17474232 57.719563 0.2419636 123 128 6.0069324 0.2065098 2.8308749 5.5814852 221609.1 2 4 + 52000 545.98999 -3198.2633 0 1 0.30964409 287 276 6.0069324 0.20332692 2.8308749 5.5814852 230246.21 2 4 +Loop time of 0.239709 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 52000 545.98999 -3198.2633 0 1 0.30964409 287 276 6.0069324 0.20332692 2.8308749 5.5814852 230246.21 2 4 + 52017 545.98999 -3217.9153 0 1 0.30964409 287 276 6.0069324 0.20326047 2.8308749 5.5814852 230246.21 2 4 +Loop time of 0.00786757 on 4 procs for 17 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 52000 545.98999 -3198.2633 0 1 0.30964409 287 276 6.0069324 0.20332692 2.8308749 5.5814852 230246.21 2 4 + 53000 453.58658 -3199.3577 0.23959479 260.0198 0.21650159 278 279 6.0069324 0.20366038 2.8308749 5.5814852 233492.88 2 4 +Loop time of 0.240351 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 53000 453.58658 -3199.3577 0.23959479 260.0198 0.21650159 278 279 6.0069324 0.20366038 2.8308749 5.5814852 233492.88 2 4 + 53014 453.58658 -3217.9131 0.23959479 260.0198 0.21650159 278 279 6.0069324 0.20360659 2.8308749 5.5814852 233492.88 2 4 +Loop time of 0.0067966 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 53000 453.58658 -3199.3577 0.23959479 260.0198 0.21650159 278 279 6.0069324 0.20366038 2.8308749 5.5814852 233492.88 2 4 + 54000 502.12681 -3199.1712 0.28827435 804.7747 0.19521941 550 563 6.0069324 0.20264815 2.8308749 5.5814852 239627.25 2 4 +Loop time of 0.238634 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 54000 502.12681 -3199.1712 0.28827435 804.7747 0.19521941 550 563 6.0069324 0.20264815 2.8308749 5.5814852 239627.25 2 4 + 54014 502.12681 -3217.9165 0.28827435 804.7747 0.19521941 550 563 6.0069324 0.20259562 2.8308749 5.5814852 239627.25 2 4 +Loop time of 0.00671387 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 54000 502.12681 -3199.1712 0.28827435 804.7747 0.19521941 550 563 6.0069324 0.20264815 2.8308749 5.5814852 239627.25 2 4 + 55000 470.7967 -3197.4136 0.31075641 1356.0734 0.18456394 285 283 6.0069324 0.20041818 2.8308749 5.5814852 246248.56 2 4 +Loop time of 0.240888 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 55000 470.7967 -3197.4136 0.31075641 1356.0734 0.18456394 285 283 6.0069324 0.20041818 2.8308749 5.5814852 246248.56 2 4 + 55013 470.7967 -3217.9136 0.31075641 1356.0734 0.18456394 285 283 6.0069324 0.20037082 2.8308749 5.5814852 246248.56 2 4 +Loop time of 0.00596166 on 4 procs for 13 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 55000 470.7967 -3197.4136 0.31075641 1356.0734 0.18456394 285 283 6.0069324 0.20041818 2.8308749 5.5814852 246248.56 2 4 + 56000 533.34641 -3198.1323 0.16761369 48.918113 0.24460077 287 276 6.0069324 0.19926786 2.8308749 5.5814852 252499.61 2 4 +Loop time of 0.239487 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 56000 533.34641 -3198.1323 0.16761369 48.918113 0.24460077 287 276 6.0069324 0.19926786 2.8308749 5.5814852 252499.61 2 4 + 56014 533.34641 -3217.9162 0.16761369 48.918113 0.24460077 287 276 6.0069324 0.19921805 2.8308749 5.5814852 252499.61 2 4 +Loop time of 0.00619745 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 56000 533.34641 -3198.1323 0.16761369 48.918113 0.24460077 287 276 6.0069324 0.19926786 2.8308749 5.5814852 252499.61 2 4 + 57000 516.06876 -3197.7671 0 1 0.33139119 287 276 6.0069324 0.19807018 2.8308749 5.5814852 255923.67 2 4 +Loop time of 0.241093 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 57000 516.06876 -3197.7671 0 1 0.33139119 287 276 6.0069324 0.19807018 2.8308749 5.5814852 255923.67 2 4 + 57016 516.06876 -3217.9146 0 1 0.33139119 287 276 6.0069324 0.19801459 2.8308749 5.5814852 255923.67 2 4 +Loop time of 0.00772929 on 4 procs for 16 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 57000 516.06876 -3197.7671 0 1 0.33139119 287 276 6.0069324 0.19807018 2.8308749 5.5814852 255923.67 2 4 + 58000 489.18902 -3198.6347 0.20937806 128.95422 0.22871806 544 276 6.0069324 0.20094828 2.8308749 5.5814852 256132.07 2 4 +Loop time of 0.239761 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 58000 489.18902 -3198.6347 0.20937806 128.95422 0.22871806 544 276 6.0069324 0.20094828 2.8308749 5.5814852 256132.07 2 4 + 58014 489.18902 -3217.9165 0.20937806 128.95422 0.22871806 544 276 6.0069324 0.20089978 2.8308749 5.5814852 256132.07 2 4 +Loop time of 0.00660753 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 58000 489.18902 -3198.6347 0.20937806 128.95422 0.22871806 544 276 6.0069324 0.20094828 2.8308749 5.5814852 256132.07 2 4 + 59000 522.75445 -3197.4454 0 1 0.91317104 274 556 6.0069324 0.20305085 2.8308749 5.5814852 259828.37 2 4 +Loop time of 0.241627 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 59000 522.75445 -3197.4454 0 1 0.91317104 274 556 6.0069324 0.20305085 2.8308749 5.5814852 259828.37 2 4 + 59013 522.75445 -3217.9138 0 1 0.91317104 274 556 6.0069324 0.20300612 2.8308749 5.5814852 259828.37 2 4 +Loop time of 0.00618345 on 4 procs for 13 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 59000 522.75445 -3197.4454 0.40114631 11050.253 0.1333929 547 548 6.0069324 0.20305085 2.8308749 5.5814852 259828.37 3 6 + 60000 552.18712 -3197.1906 0.21473769 146.03543 0.22659924 559 564 6.0069324 0.20126667 2.8308749 5.5814852 263208.58 3 6 +Loop time of 0.239681 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 60000 552.18712 -3197.1906 0.21473769 146.03543 0.22659924 559 564 6.0069324 0.20126667 2.8308749 5.5814852 263208.58 3 6 + 60015 552.18712 -3217.9157 0.21473769 146.03543 0.22659924 559 564 6.0069324 0.20121636 2.8308749 5.5814852 263208.58 3 6 +Loop time of 0.00685382 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 60000 552.18712 -3197.1906 0.21473769 146.03543 0.22659924 559 564 6.0069324 0.20126667 2.8308749 5.5814852 263208.58 3 6 + 61000 450.24979 -3197.259 0.20870055 126.94235 0.2289845 412 411 6.0069324 0.20103279 2.8308749 5.5814852 267126.63 3 6 +Loop time of 0.239598 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 61000 450.24979 -3197.259 0.20870055 126.94235 0.2289845 412 411 6.0069324 0.20103279 2.8308749 5.5814852 267126.63 3 6 + 61014 450.24979 -3217.9146 0.20870055 126.94235 0.2289845 412 411 6.0069324 0.20098666 2.8308749 5.5814852 267126.63 3 6 +Loop time of 0.00683248 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 61000 450.24979 -3197.259 0.20870055 126.94235 0.2289845 412 411 6.0069324 0.20103279 2.8308749 5.5814852 267126.63 3 6 + 62000 506.89399 -3197.4659 0.20762728 123.81933 0.22940595 256 267 6.0069324 0.20074194 2.8308749 5.5814852 270687.24 3 6 +Loop time of 0.238224 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 62000 506.89399 -3197.4659 0.20762728 123.81933 0.22940595 256 267 6.0069324 0.20074194 2.8308749 5.5814852 270687.24 3 6 + 62014 506.89399 -3217.9156 0.20762728 123.81933 0.22940595 256 267 6.0069324 0.20069662 2.8308749 5.5814852 270687.24 3 6 +Loop time of 0.00685287 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 62000 506.89399 -3197.4659 0.20762728 123.81933 0.22940595 256 267 6.0069324 0.20074194 2.8308749 5.5814852 270687.24 3 6 + 63000 510.04068 -3196.8255 0.063053561 4.320671 0.28044671 112 123 6.0069324 0.19930159 2.8308749 5.5814852 274694.1 3 6 +Loop time of 0.238676 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 63000 510.04068 -3196.8255 0.063053561 4.320671 0.28044671 112 123 6.0069324 0.19930159 2.8308749 5.5814852 274694.1 3 6 + 63014 510.04068 -3217.9141 0.063053561 4.320671 0.28044671 112 123 6.0069324 0.19925731 2.8308749 5.5814852 274694.1 3 6 +Loop time of 0.00670481 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 63000 510.04068 -3196.8255 0.063053561 4.320671 0.28044671 112 123 6.0069324 0.19930159 2.8308749 5.5814852 274694.1 3 6 + 64000 501.25574 -3197.7101 0.083024533 6.8683042 0.27396274 286 119 6.0069324 0.2 2.8308749 5.5814852 276114.67 3 6 +Loop time of 0.238342 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 64000 501.25574 -3197.7101 0.083024533 6.8683042 0.27396274 286 119 6.0069324 0.2 2.8308749 5.5814852 276114.67 3 6 + 64014 501.25574 -3217.9141 0.083024533 6.8683042 0.27396274 286 119 6.0069324 0.19995626 2.8308749 5.5814852 276114.67 3 6 +Loop time of 0.00604939 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 64000 501.25574 -3197.7101 0.083024533 6.8683042 0.27396274 286 119 6.0069324 0.2 2.8308749 5.5814852 276114.67 3 6 + 65000 476.31749 -3199.3383 0.15323867 35.04097 0.24983402 267 260 6.0069324 0.19838462 2.8308749 5.5814852 282281.34 3 6 +Loop time of 0.239458 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 65000 476.31749 -3199.3383 0.15323867 35.04097 0.24983402 267 260 6.0069324 0.19838462 2.8308749 5.5814852 282281.34 3 6 + 65014 476.31749 -3217.913 0.15323867 35.04097 0.24983402 267 260 6.0069324 0.1983419 2.8308749 5.5814852 282281.34 3 6 +Loop time of 0.00661784 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 65000 476.31749 -3199.3383 0.15323867 35.04097 0.24983402 267 260 6.0069324 0.19838462 2.8308749 5.5814852 282281.34 3 6 + 66000 515.81365 -3198.7056 0.21680106 153.19903 0.22577823 416 415 6.0069324 0.19919697 2.8308749 5.5814852 284618.61 3 6 +Loop time of 0.239712 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 66000 515.81365 -3198.7056 0.21680106 153.19903 0.22577823 416 415 6.0069324 0.19919697 2.8308749 5.5814852 284618.61 3 6 + 66014 515.81365 -3217.9165 0.21680106 153.19903 0.22577823 416 415 6.0069324 0.19915472 2.8308749 5.5814852 284618.61 3 6 +Loop time of 0.00680089 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 66000 515.81365 -3198.7056 0.21680106 153.19903 0.22577823 416 415 6.0069324 0.19919697 2.8308749 5.5814852 284618.61 3 6 + 67000 484.31519 -3197.7852 0.13298902 21.901246 0.25702524 275 567 6.0069324 0.19846269 2.8308749 5.5814852 289586.09 3 6 +Loop time of 0.239938 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 67000 484.31519 -3197.7852 0.13298902 21.901246 0.25702524 275 567 6.0069324 0.19846269 2.8308749 5.5814852 289586.09 3 6 + 67014 484.31519 -3217.9146 0.13298902 21.901246 0.25702524 275 567 6.0069324 0.19842123 2.8308749 5.5814852 289586.09 3 6 +Loop time of 0.00659657 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 67000 484.31519 -3197.7852 0.13298902 21.901246 0.25702524 275 567 6.0069324 0.19846269 2.8308749 5.5814852 289586.09 3 6 + 68000 484.02912 -3199.084 0.23443259 230.66083 0.21863699 412 423 6.0069324 0.19722059 2.8308749 5.5814852 298036.66 3 6 +Loop time of 0.240483 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 68000 484.02912 -3199.084 0.23443259 230.66083 0.21863699 412 423 6.0069324 0.19722059 2.8308749 5.5814852 298036.66 3 6 + 68014 484.02912 -3217.9156 0.23443259 230.66083 0.21863699 412 423 6.0069324 0.19717999 2.8308749 5.5814852 298036.66 3 6 +Loop time of 0.00666052 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 68000 484.02912 -3199.084 0.23443259 230.66083 0.21863699 412 423 6.0069324 0.19722059 2.8308749 5.5814852 298036.66 3 6 + 69000 516.84151 -3198.3447 0.20394137 113.66746 0.23084747 119 400 6.0069324 0.19605797 2.8308749 5.5814852 302894.58 3 6 +Loop time of 0.23984 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 69000 516.84151 -3198.3447 0.20394137 113.66746 0.23084747 119 400 6.0069324 0.19605797 2.8308749 5.5814852 302894.58 3 6 + 69015 516.84151 -3217.9163 0.20394137 113.66746 0.23084747 119 400 6.0069324 0.19601536 2.8308749 5.5814852 302894.58 3 6 +Loop time of 0.0070501 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 69000 516.84151 -3198.3447 0.20394137 113.66746 0.23084747 119 400 6.0069324 0.19605797 2.8308749 5.5814852 302894.58 3 6 + 70000 521.52008 -3198.1925 0.26533657 472.57625 0.2055223 128 139 6.0069324 0.19471429 2.8308749 5.5814852 308489.53 3 6 +Loop time of 0.240016 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 70000 521.52008 -3198.1925 0.26533657 472.57625 0.2055223 128 139 6.0069324 0.19471429 2.8308749 5.5814852 308489.53 3 6 + 70014 521.52008 -3217.9145 0.26533657 472.57625 0.2055223 128 139 6.0069324 0.19467535 2.8308749 5.5814852 308489.53 3 6 +Loop time of 0.00656152 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 70000 521.52008 -3198.1925 0.26533657 472.57625 0.2055223 128 139 6.0069324 0.19471429 2.8308749 5.5814852 308489.53 3 6 + 71000 456.91639 -3199.2364 0.030609593 2.0348424 0.29067211 555 275 6.0069324 0.19753521 2.8308749 5.5814852 308872.53 3 6 +Loop time of 0.238921 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 71000 456.91639 -3199.2364 0.030609593 2.0348424 0.29067211 555 275 6.0069324 0.19753521 2.8308749 5.5814852 308872.53 3 6 + 71016 456.91639 -3217.9154 0.030609593 2.0348424 0.29067211 555 275 6.0069324 0.19749071 2.8308749 5.5814852 308872.53 3 6 +Loop time of 0.00665921 on 4 procs for 16 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 71000 456.91639 -3199.2364 0.030609593 2.0348424 0.29067211 555 275 6.0069324 0.19753521 2.8308749 5.5814852 308872.53 3 6 + 72000 505.77427 -3198.8053 0.011213996 1.2972748 0.29661672 275 567 6.0069324 0.20022222 2.8308749 5.5814852 308922.44 3 6 +Loop time of 0.238494 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 72000 505.77427 -3198.8053 0.011213996 1.2972748 0.29661672 275 567 6.0069324 0.20022222 2.8308749 5.5814852 308922.44 3 6 + 72014 505.77427 -3217.9154 0.011213996 1.2972748 0.29661672 275 567 6.0069324 0.2001833 2.8308749 5.5814852 308922.44 3 6 +Loop time of 0.00666285 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 72000 505.77427 -3198.8053 0.011213996 1.2972748 0.29661672 275 567 6.0069324 0.20022222 2.8308749 5.5814852 308922.44 3 6 + 73000 505.42011 -3198.5745 0.241922 274.45031 0.21553199 262 544 6.0069324 0.19989041 2.8308749 5.5814852 312318.94 3 6 +Loop time of 0.240884 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 73000 505.42011 -3198.5745 0.241922 274.45031 0.21553199 262 544 6.0069324 0.19989041 2.8308749 5.5814852 312318.94 3 6 + 73014 505.42011 -3217.9145 0.241922 274.45031 0.21553199 262 544 6.0069324 0.19985208 2.8308749 5.5814852 312318.94 3 6 +Loop time of 0.00641418 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 73000 505.42011 -3198.5745 0.241922 274.45031 0.21553199 262 544 6.0069324 0.19989041 2.8308749 5.5814852 312318.94 3 6 + 74000 525.14325 -3197.1366 0.091100202 8.2841621 0.27129682 403 404 6.0069324 0.19893243 2.8308749 5.5814852 316054.12 3 6 +Loop time of 0.239838 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 74000 525.14325 -3197.1366 0.091100202 8.2841621 0.27129682 403 404 6.0069324 0.19893243 2.8308749 5.5814852 316054.12 3 6 + 74014 525.14325 -3217.9164 0.091100202 8.2841621 0.27129682 403 404 6.0069324 0.1988948 2.8308749 5.5814852 316054.12 3 6 +Loop time of 0.00640178 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 74000 525.14325 -3197.1366 0.091100202 8.2841621 0.27129682 403 404 6.0069324 0.19893243 2.8308749 5.5814852 316054.12 3 6 + 75000 529.75357 -3196.8628 0.27468673 587.107 0.20138617 262 553 6.0069324 0.1974 2.8308749 5.5814852 320757.39 3 6 +Loop time of 0.241485 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 75000 529.75357 -3196.8628 0.27468673 587.107 0.20138617 262 553 6.0069324 0.1974 2.8308749 5.5814852 320757.39 3 6 + 75015 529.75357 -3217.9131 0.27468673 587.107 0.20138617 262 553 6.0069324 0.19736053 2.8308749 5.5814852 320757.39 3 6 +Loop time of 0.00727272 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 75000 529.75357 -3196.8628 0.27468673 587.107 0.20138617 262 553 6.0069324 0.1974 2.8308749 5.5814852 320757.39 3 6 + 76000 494.67435 -3197.324 0.026840032 1.8643837 0.29183693 555 275 6.0069324 0.19744737 2.8308749 5.5814852 321584.51 3 6 +Loop time of 0.246189 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 76000 494.67435 -3197.324 0.026840032 1.8643837 0.29183693 555 275 6.0069324 0.19744737 2.8308749 5.5814852 321584.51 3 6 + 76015 494.67435 -3217.9124 0.026840032 1.8643837 0.29183693 555 275 6.0069324 0.19740841 2.8308749 5.5814852 321584.51 3 6 +Loop time of 0.00856209 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 76000 494.67435 -3197.324 0.026840032 1.8643837 0.29183693 555 275 6.0069324 0.19744737 2.8308749 5.5814852 321584.51 3 6 + 77000 478.4265 -3198.3778 0.099536255 10.075814 0.26848366 283 272 6.0069324 0.19802597 2.8308749 5.5814852 323214.67 3 6 +Loop time of 0.244489 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 77000 478.4265 -3198.3778 0.099536255 10.075814 0.26848366 283 272 6.0069324 0.19802597 2.8308749 5.5814852 323214.67 3 6 + 77014 478.4265 -3217.9158 0.099536255 10.075814 0.26848366 283 272 6.0069324 0.19798998 2.8308749 5.5814852 323214.67 3 6 +Loop time of 0.00662231 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 77000 478.4265 -3198.3778 0.099536255 10.075814 0.26848366 283 272 6.0069324 0.19802597 2.8308749 5.5814852 323214.67 3 6 + 78000 501.53059 -3199.1386 0.013408722 1.3650665 0.29595005 420 431 6.0069324 0.19646154 2.8308749 5.5814852 328321.34 3 6 +Loop time of 0.238902 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 78000 501.53059 -3199.1386 0.013408722 1.3650665 0.29595005 420 431 6.0069324 0.19646154 2.8308749 5.5814852 328321.34 3 6 + 78014 501.53059 -3217.9148 0.013408722 1.3650665 0.29595005 420 431 6.0069324 0.19642628 2.8308749 5.5814852 328321.34 3 6 +Loop time of 0.00632596 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 78000 501.53059 -3199.1386 0.013408722 1.3650665 0.29595005 420 431 6.0069324 0.19646154 2.8308749 5.5814852 328321.34 3 6 + 79000 500.93975 -3198.0923 0.116093 14.796691 0.26287499 428 543 6.0069324 0.19506329 2.8308749 5.5814852 333018.93 3 6 +Loop time of 0.238987 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 79000 500.93975 -3198.0923 0.116093 14.796691 0.26287499 428 543 6.0069324 0.19506329 2.8308749 5.5814852 333018.93 3 6 + 79014 500.93975 -3217.9148 0.116093 14.796691 0.26287499 428 543 6.0069324 0.19502873 2.8308749 5.5814852 333018.93 3 6 +Loop time of 0.00644779 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 79000 500.93975 -3198.0923 0.116093 14.796691 0.26287499 428 543 6.0069324 0.19506329 2.8308749 5.5814852 333018.93 3 6 + 80000 521.43512 -3199.0487 0.15540998 36.852069 0.2490506 253 136 6.0069324 0.193625 2.8308749 5.5814852 337716.24 3 6 +Loop time of 0.238806 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 80000 521.43512 -3199.0487 0.15540998 36.852069 0.2490506 253 136 6.0069324 0.193625 2.8308749 5.5814852 337716.24 3 6 + 80014 521.43512 -3217.9164 0.15540998 36.852069 0.2490506 253 136 6.0069324 0.19359112 2.8308749 5.5814852 337716.24 3 6 +Loop time of 0.00644064 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 80000 521.43512 -3199.0487 0.15540998 36.852069 0.2490506 253 136 6.0069324 0.193625 2.8308749 5.5814852 337716.24 3 6 + 81000 533.69561 -3197.1168 0.24520241 296.1616 0.21415781 575 280 6.0069324 0.19222222 2.8308749 5.5814852 343062.81 3 6 +Loop time of 0.240714 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 81000 533.69561 -3197.1168 0.24520241 296.1616 0.21415781 575 280 6.0069324 0.19222222 2.8308749 5.5814852 343062.81 3 6 + 81015 533.69561 -3217.9142 0.24520241 296.1616 0.21415781 575 280 6.0069324 0.19218663 2.8308749 5.5814852 343062.81 3 6 +Loop time of 0.00675607 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 81000 533.69561 -3197.1168 0.24520241 296.1616 0.21415781 575 280 6.0069324 0.19222222 2.8308749 5.5814852 343062.81 3 6 + 82000 522.58314 -3197.6951 0.34607713 3078.2225 0.16645154 569 570 6.0069324 0.19130488 2.8308749 5.5814852 347897.31 3 6 +Loop time of 0.239094 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 82000 522.58314 -3197.6951 0.34607713 3078.2225 0.16645154 569 570 6.0069324 0.19130488 2.8308749 5.5814852 347897.31 3 6 + 82014 522.58314 -3217.917 0.34607713 3078.2225 0.16645154 569 570 6.0069324 0.19127222 2.8308749 5.5814852 347897.31 3 6 +Loop time of 0.00662041 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 82000 522.58314 -3197.6951 0.34607713 3078.2225 0.16645154 569 570 6.0069324 0.19130488 2.8308749 5.5814852 347897.31 3 6 + 83000 518.24081 -3196.6457 0.27556929 599.25687 0.20099136 512 523 6.0069324 0.18978313 2.8308749 5.5814852 355870.51 3 6 +Loop time of 0.240335 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 83000 518.24081 -3196.6457 0.27556929 599.25687 0.20099136 512 523 6.0069324 0.18978313 2.8308749 5.5814852 355870.51 3 6 + 83015 518.24081 -3217.9151 0.27556929 599.25687 0.20099136 512 523 6.0069324 0.18974884 2.8308749 5.5814852 355870.51 3 6 +Loop time of 0.00710487 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 83000 518.24081 -3196.6457 0.27556929 599.25687 0.20099136 512 523 6.0069324 0.18978313 2.8308749 5.5814852 355870.51 3 6 + 84000 524.77376 -3198.1195 0.32714869 1983.8549 0.17638944 275 567 6.0069324 0.189 2.8308749 5.5814852 358623.76 3 6 +Loop time of 0.239069 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 84000 524.77376 -3198.1195 0.32714869 1983.8549 0.17638944 275 567 6.0069324 0.189 2.8308749 5.5814852 358623.76 3 6 + 84014 524.77376 -3217.9145 0.32714869 1983.8549 0.17638944 275 567 6.0069324 0.18896851 2.8308749 5.5814852 358623.76 3 6 +Loop time of 0.00662088 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 84000 524.77376 -3198.1195 0.32714869 1983.8549 0.17638944 275 567 6.0069324 0.189 2.8308749 5.5814852 358623.76 3 6 + 85000 485.77334 -3199.2545 0.0027767134 1.0665667 0.29916583 275 567 6.0069324 0.19102353 2.8308749 5.5814852 362933.93 3 6 +Loop time of 0.240117 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 85000 485.77334 -3199.2545 0.0027767134 1.0665667 0.29916583 275 567 6.0069324 0.19102353 2.8308749 5.5814852 362933.93 3 6 + 85014 485.77334 -3217.9148 0.0027767134 1.0665667 0.29916583 275 567 6.0069324 0.19099207 2.8308749 5.5814852 362933.93 3 6 +Loop time of 0.00642967 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 85000 485.77334 -3199.2545 0.0027767134 1.0665667 0.29916583 275 567 6.0069324 0.19102353 2.8308749 5.5814852 362933.93 3 6 + 86000 520.32504 -3197.8586 0.34074416 2719.857 0.16931052 572 403 6.0069324 0.19181395 2.8308749 5.5814852 366756.98 3 6 +Loop time of 0.23899 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 86000 520.32504 -3197.8586 0.34074416 2719.857 0.16931052 572 403 6.0069324 0.19181395 2.8308749 5.5814852 366756.98 3 6 + 86014 520.32504 -3217.9156 0.34074416 2719.857 0.16931052 572 403 6.0069324 0.19178273 2.8308749 5.5814852 366756.98 3 6 +Loop time of 0.00667548 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 86000 520.32504 -3197.8586 0.34074416 2719.857 0.16931052 572 403 6.0069324 0.19181395 2.8308749 5.5814852 366756.98 3 6 + 87000 492.06505 -3198.9245 0.35508545 3794.0215 0.16150733 282 284 6.0069324 0.19096552 2.8308749 5.5814852 370757.69 3 6 +Loop time of 0.241176 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 87000 492.06505 -3198.9245 0.35508545 3794.0215 0.16150733 282 284 6.0069324 0.19096552 2.8308749 5.5814852 370757.69 3 6 + 87014 492.06505 -3217.9141 0.35508545 3794.0215 0.16150733 282 284 6.0069324 0.19093479 2.8308749 5.5814852 370757.69 3 6 +Loop time of 0.00634283 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 87000 492.06505 -3198.9245 0.35508545 3794.0215 0.16150733 282 284 6.0069324 0.19096552 2.8308749 5.5814852 370757.69 3 6 + 88000 519.1972 -3199.3527 0.27684477 617.26171 0.20041941 411 416 6.0069324 0.19025 2.8308749 5.5814852 375119.46 3 6 +Loop time of 0.239888 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 88000 519.1972 -3199.3527 0.27684477 617.26171 0.20041941 411 416 6.0069324 0.19025 2.8308749 5.5814852 375119.46 3 6 + 88014 519.1972 -3217.9152 0.27684477 617.26171 0.20041941 411 416 6.0069324 0.19021974 2.8308749 5.5814852 375119.46 3 6 +Loop time of 0.00669366 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 88000 519.1972 -3199.3527 0.27684477 617.26171 0.20041941 411 416 6.0069324 0.19025 2.8308749 5.5814852 375119.46 3 6 + 89000 524.26014 -3198.5355 0.3001416 1059.9631 0.18966948 432 431 6.0069324 0.19220225 2.8308749 5.5814852 375708.76 3 6 +Loop time of 0.241238 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 89000 524.26014 -3198.5355 0.3001416 1059.9631 0.18966948 432 431 6.0069324 0.19220225 2.8308749 5.5814852 375708.76 3 6 + 89014 524.26014 -3217.9158 0.3001416 1059.9631 0.18966948 432 431 6.0069324 0.19217202 2.8308749 5.5814852 375708.76 3 6 +Loop time of 0.00632095 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 89000 524.26014 -3198.5355 0.3001416 1059.9631 0.18966948 432 431 6.0069324 0.19220225 2.8308749 5.5814852 375708.76 3 6 + 90000 498.11952 -3200.0434 0.2737435 574.39407 0.20180726 96 141 6.0069324 0.19212222 2.8308749 5.5814852 380021.68 3 6 +Loop time of 0.240092 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 90000 498.11952 -3200.0434 0.2737435 574.39407 0.20180726 96 141 6.0069324 0.19212222 2.8308749 5.5814852 380021.68 3 6 + 90013 498.11952 -3217.9105 0.2737435 574.39407 0.20180726 96 141 6.0069324 0.19209448 2.8308749 5.5814852 380021.68 3 6 +Loop time of 0.00614023 on 4 procs for 13 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 90000 498.11952 -3200.0434 0.2737435 574.39407 0.20180726 96 141 6.0069324 0.19212222 2.8308749 5.5814852 380021.68 3 6 + 91000 518.719 -3198.4974 0 1 0.38452588 128 139 6.0069324 0.19137363 2.8308749 5.5814852 386325.64 3 6 +Loop time of 0.240887 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 91000 518.719 -3198.4974 0 1 0.38452588 128 139 6.0069324 0.19137363 2.8308749 5.5814852 386325.64 3 6 + 91015 518.719 -3217.9166 0 1 0.38452588 128 139 6.0069324 0.19134209 2.8308749 5.5814852 386325.64 3 6 +Loop time of 0.00709724 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 91000 518.719 -3198.4974 0 1 0.38452588 128 139 6.0069324 0.19137363 2.8308749 5.5814852 386325.64 3 6 + 92000 489.88256 -3197.3306 0.22381505 180.28261 0.22296478 554 556 6.0069324 0.19186957 2.8308749 5.5814852 387621.28 3 6 +Loop time of 0.241415 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 92000 489.88256 -3197.3306 0.22381505 180.28261 0.22296478 554 556 6.0069324 0.19186957 2.8308749 5.5814852 387621.28 3 6 + 92014 489.88256 -3217.9165 0.22381505 180.28261 0.22296478 554 556 6.0069324 0.19184037 2.8308749 5.5814852 387621.28 3 6 +Loop time of 0.00761282 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 92000 489.88256 -3197.3306 0.22381505 180.28261 0.22296478 554 556 6.0069324 0.19186957 2.8308749 5.5814852 387621.28 3 6 + 93000 470.86218 -3199.1842 0 1 0.35506745 275 567 6.0069324 0.19339785 2.8308749 5.5814852 388253.6 3 6 +Loop time of 0.242326 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 93000 470.86218 -3199.1842 0 1 0.35506745 275 567 6.0069324 0.19339785 2.8308749 5.5814852 388253.6 3 6 + 93015 470.86218 -3217.9141 0 1 0.35506745 275 567 6.0069324 0.19336666 2.8308749 5.5814852 388253.6 3 6 +Loop time of 0.006814 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 93000 470.86218 -3199.1842 0 1 0.35506745 275 567 6.0069324 0.19339785 2.8308749 5.5814852 388253.6 3 6 + 94000 500.15102 -3200.7696 0.21997392 164.90621 0.2245099 547 552 6.0069324 0.19425532 2.8308749 5.5814852 390879.44 3 6 +Loop time of 0.239427 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 94000 500.15102 -3200.7696 0.21997392 164.90621 0.2245099 547 552 6.0069324 0.19425532 2.8308749 5.5814852 390879.44 3 6 + 94014 500.15102 -3217.9143 0.21997392 164.90621 0.2245099 547 552 6.0069324 0.19422639 2.8308749 5.5814852 390879.44 3 6 +Loop time of 0.00671053 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 94000 500.15102 -3200.7696 0.21997392 164.90621 0.2245099 547 552 6.0069324 0.19425532 2.8308749 5.5814852 390879.44 3 6 + 95000 490.13908 -3196.2455 0.24009629 263.06397 0.21629301 404 411 6.0069324 0.19329474 2.8308749 5.5814852 393723.55 3 6 +Loop time of 0.240334 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 95000 490.13908 -3196.2455 0.24009629 263.06397 0.21629301 404 411 6.0069324 0.19329474 2.8308749 5.5814852 393723.55 3 6 + 95014 490.13908 -3217.9156 0.24009629 263.06397 0.21629301 404 411 6.0069324 0.19326626 2.8308749 5.5814852 393723.55 3 6 +Loop time of 0.00659347 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 95000 490.13908 -3196.2455 0.24009629 263.06397 0.21629301 404 411 6.0069324 0.19329474 2.8308749 5.5814852 393723.55 3 6 + 96000 487.33226 -3198.9357 0 1 0.37635306 275 567 6.0069324 0.19283333 2.8308749 5.5814852 397503.57 3 6 +Loop time of 0.239501 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 96000 487.33226 -3198.9357 0 1 0.37635306 275 567 6.0069324 0.19283333 2.8308749 5.5814852 397503.57 3 6 + 96016 487.33226 -3217.9155 0 1 0.37635306 275 567 6.0069324 0.1928012 2.8308749 5.5814852 397503.57 3 6 +Loop time of 0.00752759 on 4 procs for 16 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 96000 487.33226 -3198.9357 0 1 0.37635306 275 567 6.0069324 0.19283333 2.8308749 5.5814852 397503.57 3 6 + 97000 474.12539 -3199.8196 0.35035926 3399.8667 0.16411988 543 577 6.0069324 0.19291753 2.8308749 5.5814852 402607.83 3 6 +Loop time of 0.241445 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 97000 474.12539 -3199.8196 0.35035926 3399.8667 0.16411988 543 577 6.0069324 0.19291753 2.8308749 5.5814852 402607.83 3 6 + 97014 474.12539 -3217.9109 0.35035926 3399.8667 0.16411988 543 577 6.0069324 0.19288969 2.8308749 5.5814852 402607.83 3 6 +Loop time of 0.00657606 on 4 procs for 14 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 97000 474.12539 -3199.8196 0.35035926 3399.8667 0.16411988 543 577 6.0069324 0.19291753 2.8308749 5.5814852 402607.83 3 6 + 98000 529.81368 -3198.9595 0.31966379 1667.4989 0.18016803 219 257 6.0069324 0.19226531 2.8308749 5.5814852 408103.05 3 6 +Loop time of 0.239002 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 98000 529.81368 -3198.9595 0.31966379 1667.4989 0.18016803 219 257 6.0069324 0.19226531 2.8308749 5.5814852 408103.05 3 6 + 98013 529.81368 -3217.9152 0.31966379 1667.4989 0.18016803 219 257 6.0069324 0.1922398 2.8308749 5.5814852 408103.05 3 6 +Loop time of 0.00612688 on 4 procs for 13 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 98000 529.81368 -3198.9595 0.31966379 1667.4989 0.18016803 219 257 6.0069324 0.19226531 2.8308749 5.5814852 408103.05 3 6 + 99000 521.70465 -3199.4429 0.069318452 4.9968747 0.27842895 404 399 6.0069324 0.19121212 2.8308749 5.5814852 410506.47 3 6 +Loop time of 0.239787 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 99000 521.70465 -3199.4429 0.069318452 4.9968747 0.27842895 404 399 6.0069324 0.19121212 2.8308749 5.5814852 410506.47 3 6 + 99015 521.70465 -3217.9162 0.069318452 4.9968747 0.27842895 404 399 6.0069324 0.19118315 2.8308749 5.5814852 410506.47 3 6 +Loop time of 0.00708294 on 4 procs for 15 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 99000 521.70465 -3199.4429 0.069318452 4.9968747 0.27842895 404 399 6.0069324 0.19121212 2.8308749 5.5814852 410506.47 3 6 + 100000 513.67972 -3199.6382 0.37912459 6628.3181 0.14750449 554 556 6.0069324 0.19018 2.8308749 5.5814852 415873.98 3 6 +Loop time of 0.239291 on 4 procs for 1000 steps with 577 atoms + +Step Temp PotEng f_HG f_HG[1] f_HG[2] f_HG[3] f_HG[4] f_HG[5] f_HG[6] f_HG[7] f_HG[8] f_HG[9] f_HG[10] f_HG[11] + 100000 513.67972 -3199.6382 0.37912459 6628.3181 0.14750449 554 556 6.0069324 0.19018 2.8308749 5.5814852 415873.98 3 6 + 100015 513.67972 -3217.9139 0.37912459 6628.3181 0.14750449 554 556 6.0069324 0.19015148 2.8308749 5.5814852 415873.98 3 6 +Loop time of 0.00685054 on 4 procs for 15 steps with 577 atoms + +Final hyper stats ... + +Cummulative quantities for fix hyper: + hyper time = 415874 + event timesteps = 3 + # of atoms in events = 6 +Quantities for this hyper run: + event timesteps = 3 + # of atoms in events = 6 + max length of any bond = 5.58149 + max drift distance of any atom = 2.83087 + fraction of steps & bonds with zero bias = 0.19018 +Current quantities: + ave bonds/atom = 6.00693 + +Loop time of 25.9832 on 4 procs for 100000 steps with 577 atoms + +Performance: 1662.613 ns/day, 0.014 hours/ns, 3848.641 timesteps/s +100.4% CPU use with 4 MPI tasks x no OpenMP threads + +Hyper stats: + Dynamics time (%) = 24.8121 (95.4928) + Quench time (%) = 0.715868 (2.75512) + Other time (%) = 0.879782 (3.38596) + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 17.954 | 18.433 | 18.794 | 8.4 | 70.94 +Neigh | 1.4147 | 1.4662 | 1.5092 | 2.9 | 5.64 +Comm | 2.0975 | 2.2026 | 2.3076 | 5.6 | 8.48 +Output | 0.0030999 | 0.0031937 | 0.003444 | 0.3 | 0.01 +Modify | 2.6366 | 2.9984 | 3.4835 | 19.3 | 11.54 +Other | | 0.8798 | | | 3.39 + +Nlocal: 144.25 ave 150 max 139 min +Histogram: 1 0 1 0 0 0 1 0 0 1 +Nghost: 533.25 ave 538 max 527 min +Histogram: 1 0 0 0 1 0 0 0 1 1 +Neighs: 3359.25 ave 3495 max 3245 min +Histogram: 1 0 1 0 0 1 0 0 0 1 + +Total # of neighbors = 13437 +Ave neighs/atom = 23.2877 +Neighbor list builds = 10069 +Dangerous builds = 0 +Total wall time: 0:00:26 diff --git a/examples/hyper/log.10Oct18.hyper.local.g++.16 b/examples/hyper/log.10Oct18.hyper.local.g++.16 new file mode 100644 index 0000000000000000000000000000000000000000..480fcf0248c2d05c84afb5dce2c24f3f1f5b36a9 --- /dev/null +++ b/examples/hyper/log.10Oct18.hyper.local.g++.16 @@ -0,0 +1,993 @@ +LAMMPS (10 Oct 2018) +# 3d EAM surface for local HD + +# nearest neighbor distance = a * sqrt(2)/2 = 2.77 Angs for Pt with a = 3.92 +# hop event on (100) surface is same distance +# exchange event is 2 atoms moving same distance + +variable Tequil index 400.0 +variable Vmax index 0.4 +variable qfactor index 0.3 +variable cutbond index 3.2 +variable Dcut index 10.0 +variable cutevent index 1.1 +variable alpha index 200.0 +variable boost index 4000.0 +variable ghostcut index 12.0 +variable steps index 1500 +variable nevent index 100 +variable nx index 8 +variable ny index 8 +variable zoom index 1.8 +variable seed index 826626413 +variable tol index 1.0e-15 +variable add index 37K + +units metal +atom_style atomic +atom_modify map array +boundary p p p +comm_modify cutoff ${ghostcut} +comm_modify cutoff 12.0 + +lattice fcc 3.92 +Lattice spacing in x,y,z = 3.92 3.92 3.92 +region box block 0 6 0 6 0 4 +create_box 2 box +Created orthogonal box = (0 0 0) to (23.52 23.52 15.68) + 2 by 4 by 2 MPI processor grid +create_atoms 1 box +Created 576 atoms + Time spent = 0.00108504 secs + +mass * 1.0 + +change_box all z final -0.1 5.0 boundary p p f + orthogonal box = (0 0 -0.392) to (23.52 23.52 19.6) + +# replicate in xy + +replicate ${nx} ${ny} 1 +replicate 8 ${ny} 1 +replicate 8 8 1 + orthogonal box = (0 0 -0.392) to (188.16 188.16 19.6) + 4 by 4 by 1 MPI processor grid + 36864 atoms + Time spent = 0.0028758 secs + +# add adatoms + +include adatoms.list.${add} +include adatoms.list.37K +create_atoms 1 single 27.5 9.5 4 +Created 1 atoms + Time spent = 0.000183105 secs +create_atoms 1 single 16 9 4 +Created 1 atoms + Time spent = 0.000178099 secs +create_atoms 1 single 10 12 4 +Created 1 atoms + Time spent = 0.000179768 secs +create_atoms 1 single 31 44 4 +Created 1 atoms + Time spent = 0.000184059 secs +create_atoms 1 single 13 17 4 +Created 1 atoms + Time spent = 0.000173807 secs +create_atoms 1 single 8.5 28.5 4 +Created 1 atoms + Time spent = 0.000167847 secs +create_atoms 1 single 23 26 4 +Created 1 atoms + Time spent = 0.000179052 secs +create_atoms 1 single 38 27 4 +Created 1 atoms + Time spent = 0.000169992 secs +create_atoms 1 single 37.5 4.5 4 +Created 1 atoms + Time spent = 0.000166178 secs +create_atoms 1 single 41.5 47.5 4 +Created 1 atoms + Time spent = 0.000172138 secs +create_atoms 1 single 20.5 37.5 4 +Created 1 atoms + Time spent = 0.000165939 secs +create_atoms 1 single 5 8 4 +Created 1 atoms + Time spent = 0.00018096 secs +create_atoms 1 single 2.5 16.5 4 +Created 1 atoms + Time spent = 0.000165939 secs +create_atoms 1 single 38.5 45.5 4 +Created 1 atoms + Time spent = 0.000164986 secs +create_atoms 1 single 9 0 4 +Created 1 atoms + Time spent = 0.000168085 secs +create_atoms 1 single 39 32 4 +Created 1 atoms + Time spent = 0.000170946 secs +create_atoms 1 single 45.5 11.5 4 +Created 1 atoms + Time spent = 0.00018096 secs +create_atoms 1 single 40 0 4 +Created 1 atoms + Time spent = 0.000168085 secs +create_atoms 1 single 44.5 2.5 4 +Created 1 atoms + Time spent = 0.000165939 secs +create_atoms 1 single 4.5 44.5 4 +Created 1 atoms + Time spent = 0.000168085 secs +create_atoms 1 single 24.5 13.5 4 +Created 1 atoms + Time spent = 0.000165939 secs +create_atoms 1 single 47.5 23.5 4 +Created 1 atoms + Time spent = 0.00018096 secs +create_atoms 1 single 1 20 4 +Created 1 atoms + Time spent = 0.000166893 secs +create_atoms 1 single 38.5 31.5 4 +Created 1 atoms + Time spent = 0.000168085 secs +create_atoms 1 single 12.5 12.5 4 +Created 1 atoms + Time spent = 0.000169992 secs +create_atoms 1 single 2 27 4 +Created 1 atoms + Time spent = 0.000188828 secs +create_atoms 1 single 21 5 4 +Created 1 atoms + Time spent = 0.000174999 secs +create_atoms 1 single 47 12 4 +Created 1 atoms + Time spent = 0.000164986 secs +create_atoms 1 single 32.5 46.5 4 +Created 1 atoms + Time spent = 0.000165939 secs +create_atoms 1 single 9.5 40.5 4 +Created 1 atoms + Time spent = 0.000166893 secs +create_atoms 1 single 8.5 2.5 4 +Created 1 atoms + Time spent = 0.000164986 secs +create_atoms 1 single 41.5 22.5 4 +Created 1 atoms + Time spent = 0.000174046 secs +create_atoms 1 single 29 11 4 +Created 1 atoms + Time spent = 0.000166893 secs +create_atoms 1 single 3.5 3.5 4 +Created 1 atoms + Time spent = 0.000165224 secs +create_atoms 1 single 5 21 4 +Created 1 atoms + Time spent = 0.000164986 secs +create_atoms 1 single 46.5 31.5 4 +Created 1 atoms + Time spent = 0.000166178 secs +create_atoms 1 single 35 46 4 +Created 1 atoms + Time spent = 0.000183105 secs +create_atoms 1 single 40.5 41.5 4 +Created 1 atoms + Time spent = 0.000164986 secs +create_atoms 1 single 10 22 4 +Created 1 atoms + Time spent = 0.000164986 secs +create_atoms 1 single 43.5 14.5 4 +Created 1 atoms + Time spent = 0.000169992 secs +create_atoms 1 single 42 42 4 +Created 1 atoms + Time spent = 0.000165939 secs +create_atoms 1 single 4 26 4 +Created 1 atoms + Time spent = 0.000174999 secs +create_atoms 1 single 19 34 4 +Created 1 atoms + Time spent = 0.000163078 secs +create_atoms 1 single 33 9 4 +Created 1 atoms + Time spent = 0.000164986 secs +create_atoms 1 single 0.5 45.5 4 +Created 1 atoms + Time spent = 0.000163078 secs +create_atoms 1 single 30.5 32.5 4 +Created 1 atoms + Time spent = 0.000164986 secs +create_atoms 1 single 25.5 5.5 4 +Created 1 atoms + Time spent = 0.000178099 secs +create_atoms 1 single 47.5 39.5 4 +Created 1 atoms + Time spent = 0.000165939 secs +create_atoms 1 single 15 13 4 +Created 1 atoms + Time spent = 0.000164986 secs +create_atoms 1 single 21 21 4 +Created 1 atoms + Time spent = 0.000164986 secs +create_atoms 1 single 14 28 4 +Created 1 atoms + Time spent = 0.000164986 secs +create_atoms 1 single 9 34 4 +Created 1 atoms + Time spent = 0.000174999 secs +create_atoms 1 single 7 38 4 +Created 1 atoms + Time spent = 0.000175953 secs +create_atoms 1 single 11 35 4 +Created 1 atoms + Time spent = 0.000154972 secs +create_atoms 1 single 20.5 45.5 4 +Created 1 atoms + Time spent = 0.000156879 secs +create_atoms 1 single 30.5 31.5 4 +Created 1 atoms + Time spent = 0.000159979 secs +create_atoms 1 single 32.5 2.5 4 +Created 1 atoms + Time spent = 0.000166178 secs +create_atoms 1 single 21.5 3.5 4 +Created 1 atoms + Time spent = 0.000157833 secs +create_atoms 1 single 23 12 4 +Created 1 atoms + Time spent = 0.000155926 secs +create_atoms 1 single 4.5 33.5 4 +Created 1 atoms + Time spent = 0.000156879 secs +create_atoms 1 single 46 43 4 +Created 1 atoms + Time spent = 0.000155926 secs +create_atoms 1 single 42.5 45.5 4 +Created 1 atoms + Time spent = 0.000156879 secs +create_atoms 1 single 4.5 10.5 4 +Created 1 atoms + Time spent = 0.000158072 secs +create_atoms 1 single 33.5 15.5 4 +Created 1 atoms + Time spent = 0.000157833 secs +create_atoms 1 single 24 5 4 +Created 1 atoms + Time spent = 0.000154018 secs +create_atoms 1 single 13 16 4 +Created 1 atoms + Time spent = 0.000158072 secs +create_atoms 1 single 16.5 23.5 4 +Created 1 atoms + Time spent = 0.000156164 secs +create_atoms 1 single 45.5 28.5 4 +Created 1 atoms + Time spent = 0.000247002 secs +create_atoms 1 single 44.5 5.5 4 +Created 1 atoms + Time spent = 0.000156164 secs +create_atoms 1 single 27.5 46.5 4 +Created 1 atoms + Time spent = 0.000155926 secs +create_atoms 1 single 44.5 12.5 4 +Created 1 atoms + Time spent = 0.000157833 secs +create_atoms 1 single 12 41 4 +Created 1 atoms + Time spent = 0.000156879 secs +create_atoms 1 single 6 4 4 +Created 1 atoms + Time spent = 0.0001688 secs +create_atoms 1 single 31.5 10.5 4 +Created 1 atoms + Time spent = 0.00015521 secs +create_atoms 1 single 1 44 4 +Created 1 atoms + Time spent = 0.000154972 secs +create_atoms 1 single 31 4 4 +Created 1 atoms + Time spent = 0.000156879 secs +create_atoms 1 single 21 33 4 +Created 1 atoms + Time spent = 0.000156879 secs +create_atoms 1 single 3 33 4 +Created 1 atoms + Time spent = 0.000164032 secs +create_atoms 1 single 15 10 4 +Created 1 atoms + Time spent = 0.0001719 secs +create_atoms 1 single 28.5 22.5 4 +Created 1 atoms + Time spent = 0.000153065 secs +create_atoms 1 single 43 1 4 +Created 1 atoms + Time spent = 0.000155926 secs +create_atoms 1 single 3.5 0.5 4 +Created 1 atoms + Time spent = 0.000154972 secs +create_atoms 1 single 41 37 4 +Created 1 atoms + Time spent = 0.000153065 secs +create_atoms 1 single 18.5 43.5 4 +Created 1 atoms + Time spent = 0.000213146 secs +create_atoms 1 single 17 27 4 +Created 1 atoms + Time spent = 0.000159979 secs +create_atoms 1 single 3 5 4 +Created 1 atoms + Time spent = 0.000153065 secs +create_atoms 1 single 18.5 23.5 4 +Created 1 atoms + Time spent = 0.000154972 secs +create_atoms 1 single 31.5 14.5 4 +Created 1 atoms + Time spent = 0.000154972 secs +create_atoms 1 single 41 31 4 +Created 1 atoms + Time spent = 0.000155926 secs +create_atoms 1 single 22 3 4 +Created 1 atoms + Time spent = 0.00015521 secs +create_atoms 1 single 14.5 40.5 4 +Created 1 atoms + Time spent = 0.000154018 secs +create_atoms 1 single 9 38 4 +Created 1 atoms + Time spent = 0.000154018 secs +create_atoms 1 single 36 42 4 +Created 1 atoms + Time spent = 0.000155926 secs +create_atoms 1 single 33 22 4 +Created 1 atoms + Time spent = 0.000163078 secs +create_atoms 1 single 15.5 47.5 4 +Created 1 atoms + Time spent = 0.000154972 secs +create_atoms 1 single 3 0 4 +Created 1 atoms + Time spent = 0.000154972 secs +create_atoms 1 single 25.5 27.5 4 +Created 1 atoms + Time spent = 0.000176907 secs +create_atoms 1 single 2.5 28.5 4 +Created 1 atoms + Time spent = 0.000154972 secs +create_atoms 1 single 29.5 28.5 4 +Created 1 atoms + Time spent = 0.000162125 secs +create_atoms 1 single 44.5 18.5 4 +Created 1 atoms + Time spent = 0.000152826 secs +create_atoms 1 single 26 40 4 +Created 1 atoms + Time spent = 0.000155926 secs +create_atoms 1 single 41 27 4 +Created 1 atoms + Time spent = 0.000158072 secs +create_atoms 1 single 39.5 5.5 4 +Created 1 atoms + Time spent = 0.000155926 secs +create_atoms 1 single 3 38 4 +Created 1 atoms + Time spent = 0.000152826 secs +create_atoms 1 single 35 29 4 +Created 1 atoms + Time spent = 0.000164986 secs +create_atoms 1 single 11 19 4 +Created 1 atoms + Time spent = 0.000164986 secs +create_atoms 1 single 18 1 4 +Created 1 atoms + Time spent = 0.000146866 secs +create_atoms 1 single 39.5 40.5 4 +Created 1 atoms + Time spent = 0.000146866 secs +create_atoms 1 single 46 17 4 +Created 1 atoms + Time spent = 0.000146151 secs +create_atoms 1 single 1.5 23.5 4 +Created 1 atoms + Time spent = 0.000154018 secs +create_atoms 1 single 28.5 23.5 4 +Created 1 atoms + Time spent = 0.000145912 secs +create_atoms 1 single 10 28 4 +Created 1 atoms + Time spent = 0.000159979 secs +create_atoms 1 single 19 47 4 +Created 1 atoms + Time spent = 0.000148058 secs +create_atoms 1 single 10.5 16.5 4 +Created 1 atoms + Time spent = 0.000147104 secs +create_atoms 1 single 38 45 4 +Created 1 atoms + Time spent = 0.000144958 secs +create_atoms 1 single 42.5 41.5 4 +Created 1 atoms + Time spent = 0.000161886 secs +create_atoms 1 single 47.5 42.5 4 +Created 1 atoms + Time spent = 0.000147104 secs +create_atoms 1 single 38 7 4 +Created 1 atoms + Time spent = 0.000146151 secs +create_atoms 1 single 10 44 4 +Created 1 atoms + Time spent = 0.000145912 secs +create_atoms 1 single 29.5 27.5 4 +Created 1 atoms + Time spent = 0.000146151 secs +create_atoms 1 single 45 30 4 +Created 1 atoms + Time spent = 0.000145912 secs +create_atoms 1 single 3 9 4 +Created 1 atoms + Time spent = 0.000154018 secs +create_atoms 1 single 8.5 35.5 4 +Created 1 atoms + Time spent = 0.000146151 secs +create_atoms 1 single 24 44 4 +Created 1 atoms + Time spent = 0.000145912 secs +create_atoms 1 single 47 4 4 +Created 1 atoms + Time spent = 0.000144958 secs +create_atoms 1 single 7.5 8.5 4 +Created 1 atoms + Time spent = 0.000144958 secs +create_atoms 1 single 32.5 41.5 4 +Created 1 atoms + Time spent = 0.000157833 secs +create_atoms 1 single 0.5 34.5 4 +Created 1 atoms + Time spent = 0.000145912 secs +create_atoms 1 single 11 8 4 +Created 1 atoms + Time spent = 0.000147104 secs +create_atoms 1 single 2 40 4 +Created 1 atoms + Time spent = 0.000144958 secs +create_atoms 1 single 25 24 4 +Created 1 atoms + Time spent = 0.000146151 secs +create_atoms 1 single 47.5 6.5 4 +Created 1 atoms + Time spent = 0.000147104 secs +create_atoms 1 single 39.5 28.5 4 +Created 1 atoms + Time spent = 0.000154972 secs +create_atoms 1 single 17 21 4 +Created 1 atoms + Time spent = 0.000164032 secs +create_atoms 1 single 32 43 4 +Created 1 atoms + Time spent = 0.000146151 secs +create_atoms 1 single 16.5 29.5 4 +Created 1 atoms + Time spent = 0.000146151 secs +create_atoms 1 single 34 34 4 +Created 1 atoms + Time spent = 0.000145912 secs +create_atoms 1 single 11.5 3.5 4 +Created 1 atoms + Time spent = 0.000154018 secs +create_atoms 1 single 39 22 4 +Created 1 atoms + Time spent = 0.000144958 secs +create_atoms 1 single 24.5 36.5 4 +Created 1 atoms + Time spent = 0.000144958 secs +create_atoms 1 single 33 31 4 +Created 1 atoms + Time spent = 0.000144958 secs +create_atoms 1 single 35.5 35.5 4 +Created 1 atoms + Time spent = 0.000146151 secs +create_atoms 1 single 14.5 34.5 4 +Created 1 atoms + Time spent = 0.000146866 secs +create_atoms 1 single 34 28 4 +Created 1 atoms + Time spent = 0.000153065 secs +create_atoms 1 single 37 41 4 +Created 1 atoms + Time spent = 0.000145912 secs +create_atoms 1 single 33 46 4 +Created 1 atoms + Time spent = 0.000144958 secs +create_atoms 1 single 27.5 28.5 4 +Created 1 atoms + Time spent = 0.000145197 secs +create_atoms 1 single 40.5 22.5 4 +Created 1 atoms + Time spent = 0.000150919 secs +create_atoms 1 single 27.5 1.5 4 +Created 1 atoms + Time spent = 0.000146151 secs +create_atoms 1 single 12 2 4 +Created 1 atoms + Time spent = 0.000151873 secs +create_atoms 1 single 36 43 4 +Created 1 atoms + Time spent = 0.000144005 secs +create_atoms 1 single 28.5 9.5 4 +Created 1 atoms + Time spent = 0.000146151 secs +create_atoms 1 single 20.5 25.5 4 +Created 1 atoms + Time spent = 0.000144958 secs +create_atoms 1 single 3 3 4 +Created 1 atoms + Time spent = 0.000144005 secs +create_atoms 1 single 38 33 4 +Created 1 atoms + Time spent = 0.000146151 secs +create_atoms 1 single 3 20 4 +Created 1 atoms + Time spent = 0.000154972 secs +create_atoms 1 single 35 11 4 +Created 1 atoms + Time spent = 0.000145912 secs +create_atoms 1 single 5 25 4 +Created 1 atoms + Time spent = 0.000144005 secs +create_atoms 1 single 36.5 6.5 4 +Created 1 atoms + Time spent = 0.000144005 secs +create_atoms 1 single 19.5 24.5 4 +Created 1 atoms + Time spent = 0.000236988 secs +create_atoms 1 single 27 41 4 +Created 1 atoms + Time spent = 0.000169992 secs +create_atoms 1 single 39.5 11.5 4 +Created 1 atoms + Time spent = 0.000138998 secs +create_atoms 1 single 21.5 2.5 4 +Created 1 atoms + Time spent = 0.000136852 secs +create_atoms 1 single 46.5 15.5 4 +Created 1 atoms + Time spent = 0.000138998 secs +create_atoms 1 single 13 24 4 +Created 1 atoms + Time spent = 0.000137091 secs +create_atoms 1 single 11 37 4 +Created 1 atoms + Time spent = 0.000144005 secs +create_atoms 1 single 11.5 31.5 4 +Created 1 atoms + Time spent = 0.000144958 secs +create_atoms 1 single 47 0 4 +Created 1 atoms + Time spent = 0.000138044 secs +create_atoms 1 single 25.5 17.5 4 +Created 1 atoms + Time spent = 0.00014019 secs +create_atoms 1 single 32 11 4 +Created 1 atoms + Time spent = 0.000138044 secs +create_atoms 1 single 8 17 4 +Created 1 atoms + Time spent = 0.000138044 secs +create_atoms 1 single 27.5 12.5 4 +Created 1 atoms + Time spent = 0.000137806 secs +create_atoms 1 single 25 7 4 +Created 1 atoms + Time spent = 0.000146151 secs +create_atoms 1 single 25.5 37.5 4 +Created 1 atoms + Time spent = 0.000139952 secs +create_atoms 1 single 12 15 4 +Created 1 atoms + Time spent = 0.000138044 secs +create_atoms 1 single 1 7 4 +Created 1 atoms + Time spent = 0.000138998 secs +create_atoms 1 single 18.5 47.5 4 +Created 1 atoms + Time spent = 0.000138044 secs +create_atoms 1 single 5 38 4 +Created 1 atoms + Time spent = 0.000136852 secs +create_atoms 1 single 42 19 4 +Created 1 atoms + Time spent = 0.000149012 secs +create_atoms 1 single 30.5 7.5 4 +Created 1 atoms + Time spent = 0.000138044 secs +create_atoms 1 single 42.5 7.5 4 +Created 1 atoms + Time spent = 0.000138998 secs +create_atoms 1 single 26.5 18.5 4 +Created 1 atoms + Time spent = 0.000153065 secs +create_atoms 1 single 18.5 1.5 4 +Created 1 atoms + Time spent = 0.000137091 secs +create_atoms 1 single 41.5 10.5 4 +Created 1 atoms + Time spent = 0.000140905 secs + +# define frozen substrate and mobile atoms + +region base block INF INF INF INF 0 1.8 +set region base type 2 + 18432 settings made for type +group base type 2 +18432 atoms in group base +group mobile type 1 +18616 atoms in group mobile + +# pair style + +pair_style eam/alloy +pair_coeff * * ptvoterlammps.eam Pt Pt + +neighbor 0.5 bin +neigh_modify every 1 delay 5 check yes + +fix 1 mobile nve +fix 2 mobile langevin ${Tequil} ${Tequil} 1.0 ${seed} zero yes +fix 2 mobile langevin 400.0 ${Tequil} 1.0 ${seed} zero yes +fix 2 mobile langevin 400.0 400.0 1.0 ${seed} zero yes +fix 2 mobile langevin 400.0 400.0 1.0 826626413 zero yes + +timestep 0.005 + +compute tmobile mobile temp + +thermo 100 +thermo_modify temp tmobile +WARNING: Temperature for thermo pressure is not for group all (../thermo.cpp:488) + +# thermal equilibration + +run 1000 +Neighbor list info ... + update every 1 steps, delay 5 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.07583 + ghost atom cutoff = 12 + binsize = 3.03792, bins = 62 62 7 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair eam/alloy, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d/newton + bin: standard +Per MPI rank memory allocation (min/avg/max) = 3.359 | 3.359 | 3.36 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -206220.22 0 -206220.22 -52155.664 + 100 188.18127 -206044.43 0 -205591.63 -25068.83 + 200 274.34464 -205860.78 0 -205200.66 -40191.797 + 300 325.66286 -205750.01 0 -204966.4 -31510.222 + 400 352.48242 -205675.42 0 -204827.28 -35058.064 + 500 370.88571 -205619.66 0 -204727.25 -32735.022 + 600 388.62129 -205592.87 0 -204657.78 -33904.556 + 700 389.54874 -205579.73 0 -204642.4 -32769.852 + 800 395.56074 -205576.82 0 -204625.03 -33755.948 + 900 398.03458 -205564.48 0 -204606.74 -32777.103 + 1000 401.24089 -205562.85 0 -204597.4 -33785.341 +Loop time of 4.3687 on 16 procs for 1000 steps with 37048 atoms + +Performance: 98.885 ns/day, 0.243 hours/ns, 228.901 timesteps/s +98.4% CPU use with 16 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 3.2988 | 3.3828 | 3.4667 | 2.3 | 77.43 +Neigh | 0.20856 | 0.23127 | 0.24382 | 1.9 | 5.29 +Comm | 0.33313 | 0.45075 | 0.55485 | 9.2 | 10.32 +Output | 0.00042987 | 0.00044042 | 0.00049591 | 0.0 | 0.01 +Modify | 0.18811 | 0.28363 | 0.36798 | 9.7 | 6.49 +Other | | 0.01983 | | | 0.45 + +Nlocal: 2315.5 ave 2332 max 2297 min +Histogram: 2 0 0 3 4 0 2 1 2 2 +Nghost: 3186.31 ave 3205 max 3170 min +Histogram: 2 1 3 0 2 3 2 1 0 2 +Neighs: 55590.9 ave 56174 max 55103 min +Histogram: 2 2 1 1 4 1 3 0 0 2 + +Total # of neighbors = 889454 +Ave neighs/atom = 24.0082 +Neighbor list builds = 105 +Dangerous builds = 0 +reset_timestep 0 + +# pin base so will not move during quenches + +fix freeze base setforce 0.0 0.0 0.0 + +# event detection + +compute event all event/displace ${cutevent} +compute event all event/displace 1.1 + +# hyper/local + +fix HL mobile hyper/local ${cutbond} ${qfactor} ${Vmax} ${Tequil} ${Dcut} ${alpha} ${boost} +fix HL mobile hyper/local 3.2 ${qfactor} ${Vmax} ${Tequil} ${Dcut} ${alpha} ${boost} +fix HL mobile hyper/local 3.2 0.3 ${Vmax} ${Tequil} ${Dcut} ${alpha} ${boost} +fix HL mobile hyper/local 3.2 0.3 0.4 ${Tequil} ${Dcut} ${alpha} ${boost} +fix HL mobile hyper/local 3.2 0.3 0.4 400.0 ${Dcut} ${alpha} ${boost} +fix HL mobile hyper/local 3.2 0.3 0.4 400.0 10.0 ${alpha} ${boost} +fix HL mobile hyper/local 3.2 0.3 0.4 400.0 10.0 200.0 ${boost} +fix HL mobile hyper/local 3.2 0.3 0.4 400.0 10.0 200.0 4000.0 + +# thermo output + +thermo_style custom step temp pe f_HL f_HL[*] +WARNING: New thermo_style command, previous thermo_modify settings will be lost (../output.cpp:705) + +thermo_modify lost ignore +thermo_modify temp tmobile +WARNING: Temperature for thermo pressure is not for group all (../thermo.cpp:488) + +thermo ${nevent} +thermo 100 + +# dump + +region substrate block INF INF INF INF 1.8 3.8 +region adatoms block INF INF INF INF 3.8 INF +variable acolor atom rmask(base)+2*rmask(substrate)+3*rmask(adatoms) + +dump 1 all image 10000000 local.*.jpg v_acolor type size 1024 1024 zoom ${zoom} adiam 2.5 view 0.0 0.0 up 0 1 0 axes yes 0.9 0.01 +dump 1 all image 10000000 local.*.jpg v_acolor type size 1024 1024 zoom 1.8 adiam 2.5 view 0.0 0.0 up 0 1 0 axes yes 0.9 0.01 +dump_modify 1 pad 6 amap 1 3 sa 1 3 blue red green + +# run + +hyper ${steps} ${nevent} HL event min ${tol} ${tol} 1000 1000 dump 1 +hyper 1500 ${nevent} HL event min ${tol} ${tol} 1000 1000 dump 1 +hyper 1500 100 HL event min ${tol} ${tol} 1000 1000 dump 1 +hyper 1500 100 HL event min 1.0e-15 ${tol} 1000 1000 dump 1 +hyper 1500 100 HL event min 1.0e-15 1.0e-15 1000 1000 dump 1 +WARNING: Resetting reneighboring criteria during hyper (../hyper.cpp:133) +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.07583 + ghost atom cutoff = 12 + binsize = 3.03792, bins = 62 62 7 + 2 neighbor lists, perpetual/occasional/extra = 1 1 0 + (1) pair eam/alloy, perpetual + attributes: half, newton on + pair build: half/bin/atomonly/newton + stencil: half/bin/3d/newton + bin: standard + (2) fix hyper/local, occasional + attributes: full, newton on, cut 10 + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 7.566 | 7.567 | 7.567 Mbytes +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 0 401.24089 -205562.85 0 0 0 1 0 0 0 0 0 0 0 0 4e+19 0 0 0 0 0 0 0 0 0 0 0 + 77 401.24089 -206534.96 0 0 0 1 0 0 0 0 0 0 0 0 4e+19 0 0 0 0 0 0 0 1540 0 0 0 +Loop time of 0.540347 on 16 procs for 77 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 0 401.24089 -205562.85 23.271302 74 0.18753621 1 6.0138739 703.62325 0 0.55802338 3.5350432 0 0 0 4e+19 10.115141 10.115141 0 0 0 0 0 0 0 0 0 + 100 399.15639 -205546.21 22.904368 90 0.32935524 0.39929142 6.0138739 703.62325 0.026229865 0.91517139 3.9968927 91.88 0.3995539 0.4009724 0.39695676 10.262823 10.262823 0 0 0 0 0 2000 0 0 0 +Loop time of 0.579085 on 16 procs for 100 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 100 399.15639 -205546.21 22.904368 90 0.32935524 0.39929142 6.0138739 703.62325 0.026229865 0.91517139 3.9968927 91.88 0.3995539 0.4009724 0.39695676 10.262823 10.262823 0 0 0 0 0 2000 0 0 0 + 184 399.15639 -206534.96 22.904368 90 0.32935524 0.39929142 6.0138739 703.62325 0.026229865 0.91517139 3.9968927 49.934783 0.21714886 0.4009724 0.39695676 10.262823 10.262823 0 0 0 0 0 3680 0 0 0 +Loop time of 0.556056 on 16 procs for 84 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 100 399.15639 -205546.21 22.903938 90 0.32935524 0.39929142 6.0138739 703.62325 0.026229865 0.91517139 3.9968927 91.88 0.3995539 0.4009724 0.39695676 10.262823 10.262823 0 0 0 0 0 2000 0 0 0 + 200 403.01717 -205543.17 20.844359 90 0.3291605 0.39888693 6.0138739 703.62325 0.039527213 0.94418421 4.0368484 90.95 0.39930574 0.4019706 0.39554353 10.262823 10.262823 0 0 0 0 0 4000 0 0 0 +Loop time of 0.581214 on 16 procs for 100 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 200 403.01717 -205543.17 20.844359 90 0.3291605 0.39888693 6.0138739 703.62325 0.039527213 0.94418421 4.0368484 90.95 0.39930574 0.4019706 0.39554353 10.262823 10.262823 0 0 0 0 0 4000 0 0 0 + 275 403.01717 -206534.96 20.844359 90 0.3291605 0.39888693 6.0138739 703.62325 0.039527213 0.94418421 4.0368484 66.145455 0.29040418 0.4019706 0.39554353 10.262823 10.262823 0 0 0 0 0 5500 0 0 0 +Loop time of 0.481812 on 16 procs for 75 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 200 403.01717 -205543.17 21.115577 91 0.3291605 0.39888693 6.0138739 703.62325 0.039527213 0.94418421 4.0368484 90.95 0.39930574 0.4019706 0.39554353 10.262823 10.262823 0 0 0 0 0 4000 0 0 0 + 300 399.01963 -205541.46 19.137336 85 0.32442182 0.39862755 6.0138739 703.62325 0.046873868 0.94776891 4.0368484 92.02 0.39912484 0.40296919 0.39497622 10.288936 10.288936 0 0 0 0 0 6000 0 0 0 +Loop time of 0.5757 on 16 procs for 100 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 300 399.01963 -205541.46 19.137336 85 0.32442182 0.39862755 6.0138739 703.62325 0.046873868 0.94776891 4.0368484 92.02 0.39912484 0.40296919 0.39497622 10.288936 10.288936 0 0 0 0 0 6000 0 0 0 + 377 399.01963 -206534.96 19.137336 85 0.32442182 0.39862755 6.0138739 703.62325 0.046873868 0.94776891 4.0368484 73.225464 0.31760598 0.40296919 0.39497622 10.288936 10.288936 0 0 0 0 0 7540 0 0 0 +Loop time of 0.514907 on 16 procs for 77 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 300 399.01963 -205541.46 19.137003 85 0.32442182 0.39862755 6.0138739 703.62325 0.046873868 0.94776891 4.0368484 92.02 0.39912484 0.40296919 0.39497622 10.288936 10.288936 0 0 0 0 0 6000 0 0 0 + 400 398.15351 -205544.87 20.470844 93 0.34589451 0.39828754 6.0138739 703.62325 0.049952465 0.94776891 4.0779385 92.0375 0.39894967 0.40395328 0.3932824 10.307052 10.307052 0 0 0 0 0 8000 0 0 0 +Loop time of 0.577371 on 16 procs for 100 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 400 398.15351 -205544.87 20.470844 93 0.34589451 0.39828754 6.0138739 703.62325 0.049952465 0.94776891 4.0779385 92.0375 0.39894967 0.40395328 0.3932824 10.307052 10.307052 0 0 0 0 0 8000 0 0 0 + 471 398.15351 -206534.96 20.470844 93 0.34589451 0.39828754 6.0138739 703.62325 0.049952465 0.94776891 4.0779385 78.163482 0.33881076 0.40395328 0.3932824 10.307052 10.307052 0 0 0 0 0 9420 0 0 0 +Loop time of 0.465473 on 16 procs for 71 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 400 398.15351 -205544.87 20.470689 93 0.34589451 0.39828754 6.0138739 703.62325 0.049952465 0.94776891 4.0779385 92.0375 0.39894967 0.40395328 0.3932824 10.307052 10.307052 0 0 0 0 0 8000 0 0 0 + 500 400.29399 -205544.98 17.051242 83 0.42140172 0.39805251 6.0138739 703.62325 0.056986933 1.0907861 4.0779385 91.986 0.39879563 0.40493836 0.39165573 10.307052 10.307052 0 0 0 0 0 10000 0 0 0 +Loop time of 0.579188 on 16 procs for 100 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 500 400.29399 -205544.98 17.051242 83 0.42140172 0.39805251 6.0138739 703.62325 0.056986933 1.0907861 4.0779385 91.986 0.39879563 0.40493836 0.39165573 10.307052 10.307052 0 0 0 0 0 10000 0 0 0 + 577 400.29399 -206534.96 17.051242 83 0.42140172 0.39805251 6.0138739 703.62325 0.056986933 1.0910651 4.0779385 79.710572 0.3455768 0.40493836 0.39165573 10.307052 10.307052 0 0 0 0 0 11540 0 0 0 +Loop time of 0.502193 on 16 procs for 77 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 500 400.29399 -205544.98 17.051107 83 0.42140172 0.39805251 6.0138739 703.62325 0.056986933 1.0910651 4.0779385 91.986 0.39879563 0.40493836 0.39165573 10.307052 10.307052 0 0 0 0 0 10000 0 0 0 + 600 400.96099 -205544.56 20.904479 91 0.41219484 0.39780769 6.0138739 703.62325 0.061331691 1.1358732 4.0779385 92.013333 0.39864794 0.40593806 0.39067432 10.307052 10.307052 0 0 0 0 0 12000 0 0 0 +Loop time of 0.694955 on 16 procs for 100 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 600 400.96099 -205544.56 20.904479 91 0.41219484 0.39780769 6.0138739 703.62325 0.061331691 1.1358732 4.0779385 92.013333 0.39864794 0.40593806 0.39067432 10.307052 10.307052 0 0 0 0 0 12000 0 0 0 + 680 400.96099 -206534.96 20.904479 91 0.41219484 0.39780769 6.0138739 703.62325 0.061331691 1.1358732 4.0779385 81.188235 0.35174818 0.40593806 0.39067432 10.307052 10.307052 0 0 0 0 0 13600 0 0 0 +Loop time of 0.529041 on 16 procs for 80 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 600 400.96099 -205544.56 20.904088 91 0.41219484 0.39780769 6.0138739 703.62325 0.061331691 1.1358732 4.0779385 92.013333 0.39864794 0.40593806 0.39067432 10.307052 10.307052 0 0 0 0 0 12000 0 0 0 + 700 397.78618 -205534.96 20.361513 95 0.54466603 0.39757442 6.0138739 703.62325 0.061146951 1.1853748 4.1995704 92.12 0.39850836 0.40693553 0.38981834 10.307052 10.307052 0 0 0 0 0 14000 0 0 0 +Loop time of 0.590093 on 16 procs for 100 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 700 397.78618 -205534.96 20.361513 95 0.54466603 0.39757442 6.0138739 703.62325 0.061146951 1.2139704 4.1995704 92.12 0.39850836 0.40693553 0.38981834 10.307052 10.307052 0 0 0 0 0 14000 0 0 0 + 790 397.78618 -206534.96 20.361513 95 0.54466603 0.39757442 6.0138739 703.62325 0.061146951 2.2107138 4.1995704 81.625316 0.35310868 0.40693553 0.38981834 10.307052 10.307052 0 0 0 0 0 15800 0 0 0 +Loop time of 0.594281 on 16 procs for 90 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 700 397.78618 -205534.96 20.236364 94 0.51088027 0.39757442 6.0138739 703.62325 0.061146951 2.2107138 4.205089 92.12 0.39850836 0.40693553 0.38981834 10.307052 10.307052 0 0 0 0 0 14000 1 2 6 + 800 399.66919 -205547.44 21.285461 94 0.56079766 0.39739855 6.0138739 703.62325 0.06556778 2.2107138 4.3041291 92.36625 0.3983806 0.40793368 0.38875 10.307052 10.385797 0 0 0 0 0 16000 1 2 6 +Loop time of 0.583824 on 16 procs for 100 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 800 399.66919 -205547.44 21.285461 94 0.56079766 0.39739855 6.0138739 703.62325 0.06556778 2.2107138 4.3041291 92.36625 0.3983806 0.40793368 0.38875 10.307052 10.385797 0 0 0 0 0 16000 1 2 6 + 872 399.66919 -206535.54 21.285461 94 0.56079766 0.39739855 6.0138739 703.62325 0.06556778 2.3177682 4.3041291 84.739679 0.36548679 0.40793368 0.38875 10.307052 10.385797 0 0 0 0 0 17440 1 2 6 +Loop time of 0.46886 on 16 procs for 72 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 800 399.66919 -205547.44 21.2852 94 0.44964213 0.39739855 6.0138739 703.62325 0.06556778 2.3177682 4.3041291 92.36625 0.3983806 0.40793368 0.38875 10.307052 10.385797 0 0 0 0 0 16000 2 4 13 + 900 401.5853 -205544.22 19.308189 94 0.47610389 0.39719191 6.0138739 703.62325 0.066991886 2.3177682 4.3041291 92.017778 0.39825974 0.40893337 0.3878576 10.307052 10.385797 0 0 0 0 0 18000 2 4 13 +Loop time of 0.585137 on 16 procs for 100 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 900 401.5853 -205544.22 19.308189 94 0.47610389 0.39719191 6.0138739 703.62325 0.066991886 2.3177682 4.3041291 92.017778 0.39825974 0.40893337 0.3878576 10.307052 10.385797 0 0 0 0 0 18000 2 4 13 + 975 401.5853 -206535.54 19.308189 94 0.47610389 0.39719191 6.0138739 703.62325 0.066991886 2.3177682 4.3041291 84.939487 0.36762438 0.40893337 0.3878576 10.307052 10.385797 0 0 0 0 0 19500 2 4 13 +Loop time of 0.502012 on 16 procs for 75 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 900 401.5853 -205544.22 19.307938 94 0.47610389 0.39719191 6.0138739 703.62325 0.066991886 2.3177682 4.3041291 92.017778 0.39825974 0.40893337 0.3878576 10.307052 10.385797 0 0 0 0 0 18000 2 4 13 + 1000 395.06218 -205526.35 17.514295 91 0.42044925 0.39716259 6.0138739 703.62325 0.067937867 2.3177682 4.3041291 92.511 0.39814962 0.40993184 0.3867545 10.307052 10.385797 0 0 0 0 0 20000 2 4 13 +Loop time of 0.588597 on 16 procs for 100 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 1000 395.06218 -205526.35 17.514295 91 0.42044925 0.39716259 6.0138739 703.62325 0.067937867 2.3177682 4.3041291 92.511 0.39814962 0.40993184 0.3867545 10.307052 10.385797 0 0 0 0 0 20000 2 4 13 + 1083 395.06218 -206535.54 17.514295 91 0.42044925 0.39716259 6.0138739 703.62325 0.067937867 2.3177682 4.3041291 85.421053 0.36763584 0.40993184 0.3867545 10.307052 10.385797 0 0 0 0 0 21660 2 4 13 +Loop time of 0.543222 on 16 procs for 83 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 1000 395.06218 -205526.35 17.514191 91 0.42044925 0.39716259 6.0138739 703.62325 0.067937867 2.3177682 4.3041291 92.511 0.39814962 0.40993184 0.3867545 10.307052 10.385797 0 0 0 0 0 20000 2 4 13 + 1100 400.04484 -205545.92 19.52012 89 0.58919981 0.39704631 6.0138739 703.62325 0.069136967 2.3177682 4.4265979 92.517273 0.39805636 0.41093134 0.38574293 10.307052 10.385797 0 0 0 0 0 22000 2 4 13 +Loop time of 0.590075 on 16 procs for 100 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 1100 400.04484 -205545.92 19.52012 89 0.58919981 0.39704631 6.0138739 703.62325 0.069136967 2.3177682 4.4265979 92.517273 0.39805636 0.41093134 0.38574293 10.307052 10.385797 0 0 0 0 0 22000 2 4 13 + 1177 400.04484 -206535.53 19.52012 89 0.58919981 0.39704631 6.0138739 703.62325 0.069136967 2.3177682 4.4265979 86.464741 0.37201529 0.41093134 0.38574293 10.307052 10.385797 0 0 0 0 0 23540 2 4 13 +Loop time of 0.500839 on 16 procs for 77 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 1100 400.04484 -205545.92 19.518413 89 0.429675 0.39705701 6.0137119 703.6043 0.069136967 2.3177682 4.4265979 92.517273 0.39805636 0.41093134 0.38574293 10.307052 10.385797 0 0 0 0 0 22000 3 6 19 + 1200 400.7462 -205543.2 21.169548 91 0.32511134 0.39679665 6.0137119 703.6043 0.06750442 2.3177682 4.4265979 92.376667 0.39796198 0.41191655 0.3846039 10.307052 10.385797 0 0 0 0 0 24000 3 6 19 +Loop time of 0.583971 on 16 procs for 100 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 1200 400.7462 -205543.2 21.169548 91 0.32511134 0.39679665 6.0137119 703.6043 0.06750442 2.3177682 4.4265979 92.376667 0.39796198 0.41191655 0.3846039 10.307052 10.385797 0 0 0 0 0 24000 3 6 19 + 1277 400.7462 -206535.53 21.169548 91 0.32511134 0.39679665 6.0137119 703.6043 0.06750442 2.3177682 4.4265979 86.806578 0.37396584 0.41191655 0.3846039 10.307052 10.385797 0 0 0 0 0 25540 3 6 19 +Loop time of 0.509118 on 16 procs for 77 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 1200 400.7462 -205543.2 21.169281 91 0.32511134 0.39679665 6.0137119 703.6043 0.06750442 2.3177682 4.4265979 92.376667 0.39796198 0.41191655 0.3846039 10.307052 10.385797 0 0 0 0 0 24000 3 6 19 + 1300 398.53702 -205539.33 21.35815 94 0.38773898 0.39659935 6.0137119 703.6043 0.067808168 2.3177682 4.4265979 92.500769 0.39786514 0.41289519 0.3846039 10.307052 10.385797 0 0 0 0 0 26000 3 6 19 +Loop time of 0.587306 on 16 procs for 100 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 1300 398.53702 -205539.33 21.35815 94 0.38773898 0.39659935 6.0137119 703.6043 0.067808168 2.3177682 4.4265979 92.500769 0.39786514 0.41289519 0.3846039 10.307052 10.385797 0 0 0 0 0 26000 3 6 19 + 1375 398.53702 -206535.53 21.35815 94 0.38773898 0.39659935 6.0137119 703.6043 0.067808168 2.3177682 4.4265979 87.455273 0.37616341 0.41289519 0.3846039 10.307052 10.385797 0 0 0 0 0 27500 3 6 19 +Loop time of 0.483781 on 16 procs for 75 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 1300 398.53702 -205539.33 21.35787 94 0.38773898 0.39659935 6.0137119 703.6043 0.067808168 2.3177682 4.4265979 92.500769 0.39786514 0.41289519 0.3846039 10.307052 10.385797 0 0 0 0 0 26000 3 6 19 + 1400 402.80537 -205549.3 19.481887 95 0.32554201 0.39648737 6.0137119 703.6043 0.069550538 2.3177682 4.4265979 92.666429 0.39776836 0.41389491 0.38420043 10.307052 10.385797 0 0 0 0 0 28000 3 6 19 +Loop time of 0.586411 on 16 procs for 100 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 1400 402.80537 -205549.3 19.481887 95 0.32554201 0.39648737 6.0137119 703.6043 0.069550538 2.3177682 4.4265979 92.666429 0.39776836 0.41389491 0.38420043 10.307052 10.385797 0 0 0 0 0 28000 3 6 19 + 1471 402.80537 -206535.53 19.481887 95 0.32554201 0.39648737 6.0137119 703.6043 0.069550538 2.3177682 4.4265979 88.193746 0.37856948 0.41389491 0.38420043 10.307052 10.385797 0 0 0 0 0 29420 3 6 19 +Loop time of 0.473799 on 16 procs for 71 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 1400 402.80537 -205549.3 19.481632 95 0.32554201 0.39648737 6.0137119 703.6043 0.069550538 2.3177682 4.4265979 92.666429 0.39776836 0.41389491 0.38420043 10.307052 10.385797 0 0 0 0 0 28000 3 6 19 + 1500 402.0803 -205537.7 20.903964 99 0.3340498 0.39635609 6.0137119 703.6043 0.070409086 2.3177682 4.4265979 92.857333 0.39767858 0.41489448 0.38372784 10.333041 10.385797 0 0 0 0 0 30000 3 6 19 +Loop time of 0.587342 on 16 procs for 100 steps with 37048 atoms + +Step Temp PotEng f_HL f_HL[1] f_HL[2] f_HL[3] f_HL[4] f_HL[5] f_HL[6] f_HL[7] f_HL[8] f_HL[9] f_HL[10] f_HL[11] f_HL[12] f_HL[13] f_HL[14] f_HL[15] f_HL[16] f_HL[17] f_HL[18] f_HL[19] f_HL[20] f_HL[21] f_HL[22] f_HL[23] + 1500 402.0803 -205537.7 20.903964 99 0.3340498 0.39635609 6.0137119 703.6043 0.070409086 2.3177682 4.4265979 92.857333 0.39767858 0.41489448 0.38372784 10.333041 10.385797 0 0 0 0 0 30000 3 6 19 + 1574 402.0803 -206535.53 20.903964 99 0.3340498 0.39635609 6.0137119 703.6043 0.070409086 2.3177682 4.4265979 88.491741 0.37898213 0.41489448 0.38372784 10.333041 10.385797 0 0 0 0 0 31480 3 6 19 +Loop time of 0.493982 on 16 procs for 74 steps with 37048 atoms + +Final hyper stats ... + +Cummulative quantities for fix hyper: + hyper time = 30000 + event timesteps = 3 + # of atoms in events = 6 +Quantities for this hyper run: + event timesteps = 3 + # of atoms in events = 6 + max length of any bond = 4.4266 + max drift distance of any atom = 2.31777 + fraction of steps & bonds with zero bias = 0.0704091 +Current quantities: + ave bonds/atom = 6.01371 +Cummulative quantities specific tofix hyper/local: + # of new bonds formed = 19 + max bonds/atom = 13 +Quantities for this hyper run specific to fix hyper/local: + ave boosted bonds/step = 92.8573 + ave boost coeff of all bonds = 0.397679 + max boost coeff of any bond = 0.414894 + min boost coeff of any bond = 0.383728 + max dist from my box of any non-maxstrain bond ghost atom = 10.333 + max dist from my box of any bond ghost atom = 10.3858 + count of ghost bond neighbors not found on reneighbor steps = 0 + lost bond partners = 0 + ave bias coeff for lost bond partners = 0 + bias overlaps = 0 + non-matching bias coeffs = 0 + CPU time for bond builds = 0.044807 +Current quantities specific to fix hyper/local: + neighbor bonds/bond = 703.604 + ave boost coeff for all bonds = 0.396356 + +Loop time of 17.9972 on 16 procs for 1500 steps with 37048 atoms + +Performance: 36.006 ns/day, 0.667 hours/ns, 83.346 timesteps/s +120.7% CPU use with 16 MPI tasks x no OpenMP threads + +Hyper stats: + Dynamics time (%) = 8.87027 (49.2869) + Quench time (%) = 8.15972 (45.3388) + Other time (%) = 1.2212 (6.78552) + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 11.6 | 11.848 | 12.043 | 3.9 | 65.83 +Neigh | 0.50025 | 0.52638 | 0.55163 | 2.1 | 2.92 +Comm | 0.34528 | 0.49905 | 0.66742 | 13.3 | 2.77 +Output | 0.0021305 | 0.0021461 | 0.0022686 | 0.1 | 0.01 +Modify | 3.7498 | 3.9009 | 3.9786 | 2.8 | 21.67 +Other | | 1.221 | | | 6.79 + +Nlocal: 2315.5 ave 2361 max 2267 min +Histogram: 1 1 0 4 2 1 3 3 0 1 +Nghost: 3187.88 ave 3236 max 3141 min +Histogram: 1 0 3 2 2 1 4 1 1 1 +Neighs: 53950.6 ave 54989 max 53049 min +Histogram: 2 0 3 2 1 2 4 1 0 1 +FullNghs: 542951 ave 554654 max 533224 min +Histogram: 1 2 3 1 2 2 2 2 0 1 + +Total # of neighbors = 8687214 +Ave neighs/atom = 234.485 +Neighbor list builds = 165 +Dangerous builds = 0 +Total wall time: 0:00:22 diff --git a/examples/hyper/ptvoterlammps.eam b/examples/hyper/ptvoterlammps.eam new file mode 100644 index 0000000000000000000000000000000000000000..780f76c0da12227cf29d249c748909dc68c08a91 --- /dev/null +++ b/examples/hyper/ptvoterlammps.eam @@ -0,0 +1,1206 @@ +lammps potential file (eam alloy format) generated from Voter potential +lammps potential file (eam alloy format) generated from Voter potential +lammps potential file (eam alloy format) generated from Voter potential + 1 Pt + 2000 4.4701153864882436E-04 2000 2.7893112429014507E-03 5.5758331745599996E+00 + 78 195.100000 3.9200000000E+00 fcc + 0.0000000000000000E+00 -9.3726378237257005E-02 -1.4662876812087147E-01 -1.9347407019915208E-01 -2.3636618878752805E-01 + -2.7644724047124986E-01 -3.1435333587770409E-01 -3.5048959265680196E-01 -3.8513634620198733E-01 -4.1849879865649925E-01 + -4.5073342521979493E-01 -4.8196329692534651E-01 -5.1228758935937202E-01 -5.4178787113806126E-01 -5.7053231810654348E-01 + -5.9857943522197787E-01 -6.2597854370043704E-01 -6.5277186883419602E-01 -6.7899694123453103E-01 -7.0468682804639060E-01 + -7.2987087311243415E-01 -7.5457527088636300E-01 -7.7882352856138171E-01 -8.0263687477682044E-01 -8.2603453431614704E-01 + -8.4903405777178687E-01 -8.7165002801416214E-01 -8.9385220540647714E-01 -9.1561604805012164E-01 -9.3696265603603790E-01 + -9.5791522083198610E-01 -9.7849204352602093E-01 -9.9870983002189262E-01 -1.0185836829573178E+00 -1.0381272638272998E+00 + -1.0573529357206635E+00 -1.0762720270513424E+00 -1.0948948965179912E+00 -1.1132310942413695E+00 -1.1312893591364621E+00 + -1.1490778953611478E+00 -1.1666042948848379E+00 -1.1838755886047883E+00 -1.2008983345443256E+00 -1.2176788724342509E+00 + -1.2342229130270710E+00 -1.2505358671573346E+00 -1.2666228433654478E+00 -1.2824887273263106E+00 -1.2981380914574538E+00 + -1.3135752421307874E+00 -1.3288043328425232E+00 -1.3438292731518049E+00 -1.3586538134484907E+00 -1.3732814919179874E+00 + -1.3877156903481436E+00 -1.4019596852675269E+00 -1.4160165195411898E+00 -1.4298892184938752E+00 -1.4435806245935652E+00 + -1.4570934731127474E+00 -1.4704303157498337E+00 -1.4835937210293269E+00 -1.4965861005543943E+00 -1.5094097763634138E+00 + -1.5220668946168692E+00 -1.5345597844428560E+00 -1.5468904285465384E+00 -1.5590608388617706E+00 -1.5710730238967714E+00 + -1.5829287935901264E+00 -1.5946300239478917E+00 -1.6061784714959348E+00 -1.6175758053312737E+00 -1.6288236803495129E+00 + -1.6399237328328120E+00 -1.6508775658053350E+00 -1.6616864780633585E+00 -1.6723521585867245E+00 -1.6828759298168119E+00 + -1.6932591433668713E+00 -1.7035031469456148E+00 -1.7136092934673612E+00 -1.7235788404216321E+00 -1.7334129925527970E+00 + -1.7431129415525604E+00 -1.7526799118629599E+00 -1.7621150270123394E+00 -1.7714193942410039E+00 -1.7805940695781992E+00 + -1.7896401398323107E+00 -1.7985586680727887E+00 -1.8073505775972039E+00 -1.8160168872573059E+00 -1.8245585986617567E+00 + -1.8329766123728359E+00 -1.8412717487946277E+00 -1.8494450474624169E+00 -1.8574973381639921E+00 -1.8654294796444515E+00 + -1.8732423326875589E+00 -1.8809365751665037E+00 -1.8885131534009967E+00 -1.8959729006831632E+00 -1.9033163629652998E+00 + -1.9105445288673943E+00 -1.9176579902949664E+00 -1.9246574529251665E+00 -1.9315437280249601E+00 -1.9383174597431190E+00 + -1.9449793109628810E+00 -1.9515299486677091E+00 -1.9579700404692790E+00 -1.9643002552280855E+00 -1.9705211806583449E+00 + -1.9766333617405571E+00 -1.9826376027386075E+00 -1.9885342577894889E+00 -1.9943241758785375E+00 -2.0000076194536822E+00 + -2.0055854487720719E+00 -2.0110580672478360E+00 -2.0164259310925137E+00 -2.0216897348658018E+00 -2.0268499570172342E+00 + -2.0319070992763257E+00 -2.0368616660436532E+00 -2.0417141625193631E+00 -2.0464650972204006E+00 -2.0511149792156478E+00 + -2.0556626254641155E+00 -2.0600932062541855E+00 -2.0644029110757671E+00 -2.0685927252091338E+00 -2.0726642405205045E+00 + -2.0766183085015473E+00 -2.0804563084627521E+00 -2.0841789444472600E+00 -2.0877876715975767E+00 -2.0912833087049787E+00 + -2.0946667371754817E+00 -2.0979390461364646E+00 -2.1011011655638017E+00 -2.1041539689908264E+00 -2.1070983231799296E+00 + -2.1099350832445327E+00 -2.1126651052269048E+00 -2.1152891919828996E+00 -2.1178081002315121E+00 -2.1202224086609767E+00 + -2.1225331395390516E+00 -2.1247409727944659E+00 -2.1268464388156634E+00 -2.1288503994083841E+00 -2.1307534549669689E+00 + -2.1325562312248580E+00 -2.1342594040743301E+00 -2.1358635733000813E+00 -2.1373694251012334E+00 -2.1387773840979936E+00 + -2.1400882690849263E+00 -2.1413025681337436E+00 -2.1424205997532089E+00 -2.1434431817712398E+00 -2.1443708051870782E+00 + -2.1452039706239008E+00 -2.1459431731625007E+00 -2.1465889038340724E+00 -2.1471416488460342E+00 -2.1476018892305180E+00 + -2.1479701028306253E+00 -2.1482467654917219E+00 -2.1484323484895125E+00 -2.1485273190235694E+00 -2.1485321403519091E+00 + -2.1484470126563591E+00 -2.1482725478832414E+00 -2.1480092510592486E+00 -2.1476573945273758E+00 -2.1472172776186471E+00 + -2.1466895754411510E+00 -2.1460744063021546E+00 -2.1453723228679569E+00 -2.1445836347777654E+00 -2.1437087028088562E+00 + -2.1427479348394045E+00 -2.1417016141723875E+00 -2.1405702824184050E+00 -2.1393539195776055E+00 -2.1380532461224977E+00 + -2.1366685327320152E+00 -2.1351997870841490E+00 -2.1336477168065300E+00 -2.1320125854350511E+00 -2.1302946140875285E+00 + -2.1284939647118084E+00 -2.1266112022137014E+00 -2.1246465848666309E+00 -2.1226003978007930E+00 -2.1204729315273694E+00 + -2.1182644700383473E+00 -2.1159753039047646E+00 -2.1136057135585435E+00 -2.1111559947046752E+00 -2.1086264260009924E+00 + -2.1060172997588604E+00 -2.1033288899537994E+00 -2.1005614905898651E+00 -2.0977153768416836E+00 -2.0947907756248489E+00 + -2.0917878008182256E+00 -2.0887069013851285E+00 -2.0855483983675080E+00 -2.0823124544060909E+00 -2.0789991822719793E+00 + -2.0756090236745779E+00 -2.0721422672568037E+00 -2.0685988388129202E+00 -2.0649793952896509E+00 -2.0612838733299972E+00 + -2.0575126163591118E+00 -2.0536659818292007E+00 -2.0497438839450974E+00 -2.0457469740596648E+00 -2.0416750125893741E+00 + -2.0375286763573190E+00 -2.0333078083100737E+00 -2.0290129419057399E+00 -2.0246440675858621E+00 -2.0202016369559090E+00 + -2.0156855754611871E+00 -2.0110963702778593E+00 -2.0064341266571577E+00 -2.0016989141897725E+00 -1.9968912606852574E+00 + -1.9920112279851745E+00 -1.9870587421187833E+00 -1.9820344220723491E+00 -1.9769384024112195E+00 -1.9717707649824567E+00 + -1.9665315667050240E+00 -1.9612212607967281E+00 -1.9558400270662160E+00 -1.9503880438033223E+00 -1.9448654878631326E+00 + -1.9392725542582359E+00 -1.9336093325766290E+00 -1.9278760759446676E+00 -1.9220730338277285E+00 -1.9162003844413846E+00 + -1.9102583041383305E+00 -1.9042469924777814E+00 -1.8981666388660647E+00 -1.8920174217314303E+00 -1.8857995289542948E+00 + -1.8795131257938429E+00 -1.8731583274011279E+00 -1.8667353651280862E+00 -1.8602444731266670E+00 -1.8536858396902449E+00 + -1.8470596475781673E+00 -1.8403660873745857E+00 -1.8336053011192051E+00 -1.8267772295273614E+00 -1.8198823541684652E+00 + -1.8129208591254398E+00 -1.8058928763343305E+00 -1.7987983439720816E+00 -1.7916376470504742E+00 -1.7844110874963606E+00 + -1.7771185698738710E+00 -1.7697602401849712E+00 -1.7623366760227746E+00 -1.7548475274913959E+00 -1.7472932291426537E+00 + -1.7396740845471292E+00 -1.7319898389278894E+00 -1.7242412013094410E+00 -1.7164277982551550E+00 -1.7085501828347134E+00 + -1.7006083640294880E+00 -1.6926024734048197E+00 -1.6845328224364085E+00 -1.6763993548439085E+00 -1.6682024481277851E+00 + -1.6599420709883763E+00 -1.6516185230955227E+00 -1.6432318959216066E+00 -1.6347823980820475E+00 -1.6262701056273825E+00 + -1.6176954061756970E+00 -1.6090579833596674E+00 -1.6003585870484209E+00 -1.5915968441967776E+00 -1.5827732529152190E+00 + -1.5738879964921655E+00 -1.5649407514579203E+00 -1.5559323095458162E+00 -1.5468624928865635E+00 -1.5377312590161041E+00 + -1.5285392382898741E+00 -1.5192862957084381E+00 -1.5099723866302082E+00 -1.5005967213739198E+00 -1.4911587331719385E+00 + -1.4816582812824439E+00 -1.4720957140722879E+00 -1.4624713862429182E+00 -1.4527854682386121E+00 -1.4430380792507160E+00 + -1.4332291882010670E+00 -1.4233591939339838E+00 -1.4134283412843427E+00 -1.4034367925165225E+00 -1.3933847216125261E+00 + -1.3832723024089693E+00 -1.3730996761155070E+00 -1.3628669257457069E+00 -1.3525743350816732E+00 -1.3422221243968426E+00 + -1.3318104615196105E+00 -1.3213395166522290E+00 -1.3108094631132874E+00 -1.3002204741555148E+00 -1.2895727231033673E+00 + -1.2788663831419154E+00 -1.2681016277240666E+00 -1.2572786301447159E+00 -1.2463975638205269E+00 -1.2354586020832887E+00 + -1.2244619185519259E+00 -1.2134076866878465E+00 -1.2022960801071922E+00 -1.1911271694252359E+00 -1.1799011168336151E+00 + -1.1686181878604995E+00 -1.1572785561222905E+00 -1.1458823957313820E+00 -1.1344298807335367E+00 -1.1229211853242436E+00 + -1.1113563947673044E+00 -1.0997355078908317E+00 -1.0880588973041296E+00 -1.0763267922468183E+00 -1.0645393559767911E+00 + -1.0526966047430970E+00 -1.0407985722986666E+00 -1.0288456577743961E+00 -1.0168381013642347E+00 -1.0047759306248194E+00 + -9.9265898548758336E-01 -9.8048790851526724E-01 -9.6826279655934266E-01 -9.5598349845928543E-01 -9.4365030366616609E-01 + -9.3126362566484699E-01 -9.1882329657834894E-01 -9.0632944500267687E-01 -8.9378262646714668E-01 -8.8118251874624731E-01 + -8.6852951212633800E-01 -8.5582386666564914E-01 -8.4306536061223991E-01 -8.3025468293365734E-01 -8.1739141480696798E-01 + -8.0447608494390788E-01 -7.9150885377465752E-01 -7.7848947219388465E-01 -7.6541866563585603E-01 -7.5229600174299571E-01 + -7.3912212257148224E-01 -7.2589686467179004E-01 -7.1262055063701923E-01 -6.9929320913134108E-01 -6.8591510649722276E-01 + -6.7248618683331862E-01 -6.5900689854285888E-01 -6.4547697804053650E-01 -6.3189708034172021E-01 -6.1826683526546378E-01 + -6.0458684009462282E-01 -5.9085689942428754E-01 -5.7707737489495647E-01 -5.6324831564153599E-01 -5.4936984719065918E-01 + -5.3544221535350756E-01 -5.2146535035529662E-01 -5.0743967264445500E-01 -4.9336507916396255E-01 -4.7924202909137281E-01 + -4.6507019526361254E-01 -4.5085021401708919E-01 -4.3658183817218754E-01 -4.2226537511572138E-01 -4.0790122197207235E-01 + -3.9348888710768504E-01 -3.7902911057711058E-01 -3.6452190148563079E-01 -3.4996694934863609E-01 -3.3536503801841927E-01 + -3.2071602647173175E-01 -3.0601984413918992E-01 -2.9127702073369299E-01 -2.7648754767100242E-01 -2.6165129895763078E-01 + -2.4676874904049176E-01 -2.3184013284504276E-01 -2.1686516695201799E-01 -2.0184414275263507E-01 -1.8677741304503614E-01 + -1.7166506103517420E-01 -1.5650696008039314E-01 -1.4130335362578991E-01 -1.2605458512786327E-01 -1.1076073962581437E-01 + -9.5421784325569844E-02 -8.0037769568471043E-02 -6.4609086101014526E-02 -4.9135867919925351E-02 -3.3618216095798403E-02 + -1.8056263958055114E-02 -2.4498331768533018E-03 1.3200592339685919E-02 2.8894924586749249E-02 4.4633030655999203E-02 + 6.0414751303124369E-02 7.6239953392470416E-02 9.2108555163040229E-02 1.0802056324675589E-01 1.2397576336762166E-01 + 1.3997389369154420E-01 1.5601484537595034E-01 1.7209852103937251E-01 1.8822479131435854E-01 2.0439349528624218E-01 + 2.2060448901654800E-01 2.3685767571336561E-01 2.5315294999332294E-01 2.6949013147842382E-01 2.8586908164149483E-01 + 3.0228968739624468E-01 3.1875186563100721E-01 3.3525542671650682E-01 3.5180022725879762E-01 3.6838616011493230E-01 + 3.8501312452908165E-01 4.0168095080467575E-01 4.1838948236543605E-01 4.3513862100478418E-01 4.5192826270035608E-01 + 4.6875821812798202E-01 4.8562834483471040E-01 5.0253855896933253E-01 5.1948873614443958E-01 5.3647868524507603E-01 + 5.5350827755155940E-01 5.7057743231721858E-01 5.8768599861706949E-01 6.0483379125370451E-01 6.2202075436250781E-01 + 6.3924690091518499E-01 6.5651197561399777E-01 6.7381573978798859E-01 6.9115813321280439E-01 7.0853900912763812E-01 + 7.2595818116200861E-01 7.4341553974137475E-01 7.6091117634314542E-01 7.7844492852958047E-01 7.9601643067638483E-01 + 8.1362562423852203E-01 8.3127237024222567E-01 8.4895651842572761E-01 8.6667817350834675E-01 8.8443717318919435E-01 + 9.0223310376347066E-01 9.2006587462315603E-01 9.3793549126390219E-01 9.5584208377475821E-01 9.7378511789609046E-01 + 9.9176452406972726E-01 1.0097801622556903E+00 1.0278322047072626E+00 1.0459203271583175E+00 1.0640442555694720E+00 + 1.0822039052743166E+00 1.1003994586468446E+00 1.1186305871875757E+00 1.1368968790245904E+00 1.1551986360515170E+00 + 1.1735357430549394E+00 1.1919076476746078E+00 1.2103144574987208E+00 1.2287563750294439E+00 1.2472327044294611E+00 + 1.2657434116894102E+00 1.2842890603416108E+00 1.3028686512809335E+00 1.3214822950015011E+00 1.3401304168804899E+00 + 1.3588121030478884E+00 1.3775275985022428E+00 1.3962770629841874E+00 1.4150596887332012E+00 1.4338759741729805E+00 + 1.4527255871930560E+00 1.4716081394984446E+00 1.4905240400664848E+00 1.5094725770116466E+00 1.5284540917330347E+00 + 1.5474682483109845E+00 1.5665147816550740E+00 1.5855940621729949E+00 1.6047053781609033E+00 1.6238490538148784E+00 + 1.6430246263651700E+00 1.6622322126105287E+00 1.6814716446866711E+00 1.7007433185388272E+00 1.7200477411777821E+00 + 1.7393846156972781E+00 1.7587539640468350E+00 1.7781554453921806E+00 1.7975891697022677E+00 1.8170546517205248E+00 + 1.8365522715303721E+00 1.8560811469510281E+00 1.8756420823719342E+00 1.8952339849377624E+00 1.9148574649502128E+00 + 1.9345118939421841E+00 1.9541973949102269E+00 1.9739137340310351E+00 1.9936607273823694E+00 2.0134384434407822E+00 + 2.0332463913139565E+00 2.0530849366211910E+00 2.0729533244978335E+00 2.0928520853370305E+00 2.1127803984947091E+00 + 2.1327387807318892E+00 2.1527265895662748E+00 2.1727439402207014E+00 2.1927906947380285E+00 2.2128665502522700E+00 + 2.2329716958331636E+00 2.2531056391662747E+00 2.2732685476091379E+00 2.2934600246049404E+00 2.3136801738277271E+00 + 2.3339285301080688E+00 2.3542055162894790E+00 2.3745104745381691E+00 2.3948434805567067E+00 2.4152044592249351E+00 + 2.4355930656594902E+00 2.4560095487129887E+00 2.4764533684082015E+00 2.4969245658256183E+00 2.5174232171356126E+00 + 2.5379487879669145E+00 2.5585014730425435E+00 2.5790810354832701E+00 2.5996871907418657E+00 2.6203202358822946E+00 + 2.6409795370745628E+00 2.6616652153218512E+00 2.6823773718541233E+00 2.7031153079893557E+00 2.7238793697159962E+00 + 2.7446694373218592E+00 2.7654849781381210E+00 2.7863261744204859E+00 2.8071930887007985E+00 2.8280851589496949E+00 + 2.8490024044822397E+00 2.8699449740201248E+00 2.8909123754755157E+00 2.9119045095198288E+00 2.9329216633817152E+00 + 2.9539633671256524E+00 2.9750294283017151E+00 2.9961197314511963E+00 3.0172347157550141E+00 3.0383735332954402E+00 + 3.0595363131640245E+00 3.0807229522145332E+00 3.1019336159590840E+00 3.1231677593092799E+00 3.1444252781424908E+00 + 3.1657062816137276E+00 3.1870106770394511E+00 3.2083382088171506E+00 3.2296885957356953E+00 3.2510619109216670E+00 + 3.2724581057791657E+00 3.2938771407356970E+00 3.3153185364371800E+00 3.3367823403952981E+00 3.3582684205709765E+00 + 3.3797767826793388E+00 3.4013073809226100E+00 3.4228597882929854E+00 3.4444340439391028E+00 3.4660299267254961E+00 + 3.4876474739113212E+00 3.5092866090972885E+00 3.5309471938205994E+00 3.5526288864523901E+00 3.5743318107821276E+00 + 3.5960555909236533E+00 3.6178003693499021E+00 3.6395658781999010E+00 3.6613522905174625E+00 3.6831592081116140E+00 + 3.7049865235650015E+00 3.7268341857147900E+00 3.7487020048932518E+00 3.7705899603073760E+00 3.7924978630856057E+00 + 3.8144256455443015E+00 3.8363732522912350E+00 3.8583405883275672E+00 3.8803274284018632E+00 3.9023337308378179E+00 + 3.9243592463594541E+00 3.9464040664724505E+00 3.9684678414951149E+00 3.9905507223673160E+00 4.0126523448985330E+00 + 4.0347728156381022E+00 4.0569118535169313E+00 4.0790694767609921E+00 4.1012454834458287E+00 4.1234398298438899E+00 + 4.1456523458155887E+00 4.1678830013175707E+00 4.1901315603727864E+00 4.2123981076334864E+00 4.2346822714171459E+00 + 4.2569842814508112E+00 4.2793036523789416E+00 4.3016406338734914E+00 4.3239947728595816E+00 4.3463662833045413E+00 + 4.3687547793077997E+00 4.3911603552374929E+00 4.4135827764013760E+00 4.4360220279758034E+00 4.4584779480264398E+00 + 4.4809504554260959E+00 4.5034394066770798E+00 4.5259447535273507E+00 4.5484662906777897E+00 4.5710040485352579E+00 + 4.5935577549240767E+00 4.6161274881904228E+00 4.6387129472301920E+00 4.6613142215805841E+00 4.6839310171118367E+00 + 4.7065633951085681E+00 4.7292111171643008E+00 4.7518741689026180E+00 4.7745524045493086E+00 4.7972456826295415E+00 + 4.8199540260440124E+00 4.8426771560303594E+00 4.8654153364317327E+00 4.8881679636507158E+00 4.9109353676786007E+00 + 4.9337170419435958E+00 4.9565132280413238E+00 4.9793235227841510E+00 5.0021480811177392E+00 5.0249865798014417E+00 + 5.0478391551127313E+00 5.0707056201600551E+00 5.0935858915452759E+00 5.1164797858015598E+00 5.1393871589985487E+00 + 5.1623080571754034E+00 5.1852421190762534E+00 5.2081896228459588E+00 5.2311502165250783E+00 5.2541240770684281E+00 + 5.2771106510309664E+00 5.3001102092285661E+00 5.3231223404842520E+00 5.3461472417535001E+00 5.3691846915659411E+00 + 5.3922347311911834E+00 5.4152970213025622E+00 5.4383715419351537E+00 5.4614582086459844E+00 5.4845569478630942E+00 + 5.5076678457857158E+00 5.5307904172453002E+00 5.5539248596376734E+00 5.5770707953058940E+00 5.6002285088674615E+00 + 5.6233976832952628E+00 5.6465782518012109E+00 5.6697699928311209E+00 5.6929729645728129E+00 5.7161871158060018E+00 + 5.7394122852501575E+00 5.7626482598903603E+00 5.7858950212328386E+00 5.8091525961963901E+00 5.8324208821101537E+00 + 5.8556994585175923E+00 5.8789886128933837E+00 5.9022880335845240E+00 5.9255979229557161E+00 5.9489176596202604E+00 + 5.9722476058295708E+00 5.9955875020860514E+00 6.0189373547390703E+00 6.0422967901605871E+00 6.0656660299873382E+00 + 6.0890449158668414E+00 6.1124332312328260E+00 6.1358308744454222E+00 6.1592380171556611E+00 6.1826542300941716E+00 + 6.2060796544689323E+00 6.2295140253289754E+00 6.2529575852384669E+00 6.2764096864441683E+00 6.2998707798745164E+00 + 6.3233404851350414E+00 6.3468187895996930E+00 6.3703054965804968E+00 6.3938008075735180E+00 6.4173042518286385E+00 + 6.4408160006103596E+00 6.4643358901402017E+00 6.4878638299445317E+00 6.5113996219647392E+00 6.5349435679242109E+00 + 6.5584949439390883E+00 6.5820543113279548E+00 6.6056211217587242E+00 6.6291954778591382E+00 6.6527772912990404E+00 + 6.6763664259354494E+00 6.6999627991396542E+00 6.7235663911976102E+00 6.7471770150347465E+00 6.7707946471251832E+00 + 6.7944192643731860E+00 6.8180505982187301E+00 6.8416887565507993E+00 6.8653334830907671E+00 6.8889848449811888E+00 + 6.9126425932957716E+00 6.9363068325644548E+00 6.9599772776424977E+00 6.9836541203695823E+00 7.0073368842610169E+00 + 7.0310259119320984E+00 7.0547207306952870E+00 7.0784215582598708E+00 7.1021280777590112E+00 7.1258404081420794E+00 + 7.1495583185106879E+00 7.1732818625587784E+00 7.1970108626746176E+00 7.2207454007816549E+00 7.2444854309146418E+00 + 7.2682306092284721E+00 7.2919813841105494E+00 7.3157370201396636E+00 7.3394980368737537E+00 7.3632638536021995E+00 + 7.3870347335731870E+00 7.4108103780772634E+00 7.4345908251167474E+00 7.4583759686098858E+00 7.4821657350257231E+00 + 7.5059599989809023E+00 7.5297587278169384E+00 7.5535618084179941E+00 7.5773690726947560E+00 7.6011807263764926E+00 + 7.6249961985945980E+00 7.6488160830215097E+00 7.6726395937346048E+00 7.6964672119532969E+00 7.7202984648144861E+00 + 7.7441335048129512E+00 7.7679721785713145E+00 7.7918143840252263E+00 7.8156601259563256E+00 7.8395091779793091E+00 + 7.8633616489525950E+00 7.8872171505684801E+00 7.9110761506575642E+00 7.9349379025217379E+00 7.9588029197337518E+00 + 7.9826706930210811E+00 8.0065413456454575E+00 8.0304148518347009E+00 8.0542909167104444E+00 8.0781697799844920E+00 + 8.1020510278148450E+00 8.1259348309081076E+00 8.1498209225532197E+00 8.1737094426007193E+00 8.1976001579278730E+00 + 8.2214930501978412E+00 8.2453880274294740E+00 8.2692848718631300E+00 8.2931839337876561E+00 8.3170845655065175E+00 + 8.3409872192351742E+00 8.3648914247895494E+00 8.3887972877339152E+00 8.4127048029783484E+00 8.4366136870275632E+00 + 8.4605241282330557E+00 8.4844357625944262E+00 8.5083487737311483E+00 8.5322628803123344E+00 8.5561782196824847E+00 + 8.5800945547420184E+00 8.6040118026395653E+00 8.6279301240340160E+00 8.6518490154534593E+00 8.6757689707511965E+00 + 8.6996893951015313E+00 8.7236104833863379E+00 8.7475321982360938E+00 8.7714542368197126E+00 8.7953768778165902E+00 + 8.8192996575590321E+00 8.8432228247780778E+00 8.8671461041655864E+00 8.8910695783146405E+00 8.9149930826007733E+00 + 8.9389164509452126E+00 8.9628399743611293E+00 8.9867630576805109E+00 9.0106861650499344E+00 9.0346088250329437E+00 + 9.0585310744476182E+00 9.0824531054343662E+00 9.1063743989039132E+00 9.1302952992988295E+00 9.1542154229516601E+00 + 9.1781349093983540E+00 9.2020536661058188E+00 9.2259714512659823E+00 9.2498885016910037E+00 9.2738043253131242E+00 + 9.2977194058450081E+00 9.3216331880464125E+00 9.3455457235945527E+00 9.3694572838805676E+00 9.3933672450474806E+00 + 9.4172760365992136E+00 9.4411832860082647E+00 9.4650889749002207E+00 9.4889932845443337E+00 9.5128957566809547E+00 + 9.5367966568620997E+00 9.5606956753877874E+00 9.5845929829314773E+00 9.6084883426126204E+00 9.6323815993180535E+00 + 9.6562731650629168E+00 9.6801622784778409E+00 9.7040494168084592E+00 9.7279344048371055E+00 9.7518168578612698E+00 + 9.7756972655772447E+00 9.7995750536870414E+00 9.8234503970684024E+00 9.8473233547104453E+00 9.8711935666041004E+00 + 9.8950612367506601E+00 9.9189259884611758E+00 9.9427881808207648E+00 9.9666474644661651E+00 9.9905036344659877E+00 + 1.0014357202264824E+01 1.0038207480799372E+01 1.0062054691084622E+01 1.0085898869761019E+01 1.0109739662186898E+01 + 1.0133577425656050E+01 1.0157411592722928E+01 1.0181242452192732E+01 1.0205070032759895E+01 1.0228893806484278E+01 + 1.0252714205943379E+01 1.0276530924492912E+01 1.0300343967861075E+01 1.0324153281178305E+01 1.0347958548066551E+01 + 1.0371760323991843E+01 1.0395558000013491E+01 1.0419351473499734E+01 1.0443141269687514E+01 1.0466926715408977E+01 + 1.0490708090490346E+01 1.0514485277828937E+01 1.0538258013530248E+01 1.0562026654097458E+01 1.0585790771200015E+01 + 1.0609550423049955E+01 1.0633305640425879E+01 1.0657056084578578E+01 1.0680802334212579E+01 1.0704543578383859E+01 + 1.0728279979352012E+01 1.0752011964769949E+01 1.0775738836518697E+01 1.0799460905029447E+01 1.0823178061875115E+01 + 1.0846889976266041E+01 1.0870597065900540E+01 1.0894298995749873E+01 1.0917995679350540E+01 1.0941687206157091E+01 + 1.0965373219300238E+01 1.0989054171122483E+01 1.1012729705594728E+01 1.1036399550915537E+01 1.1060064205773816E+01 + 1.1083723032438815E+01 1.1107376250633761E+01 1.1131024119986289E+01 1.1154665986048808E+01 1.1178302125287980E+01 + 1.1201932536310990E+01 1.1225556833508026E+01 1.1249175446501521E+01 1.1272788048716771E+01 1.1296394564302819E+01 + 1.1319995074877289E+01 1.1343589169825929E+01 1.1367177273246208E+01 1.1390759216547343E+01 1.1414334626641180E+01 + 1.1437904014067957E+01 1.1461466887703843E+01 1.1485023009376897E+01 1.1508572973961453E+01 1.1532116197051801E+01 + 1.1555652833720799E+01 1.1579183065173527E+01 1.1602706326971159E+01 1.1626223005000670E+01 1.1649732835216172E+01 + 1.1673235537724677E+01 1.1696731713669102E+01 1.1720220765933313E+01 1.1743702672323703E+01 1.1767177964609317E+01 + 1.1790645863936039E+01 1.1814106535058119E+01 1.1837560328152929E+01 1.1861006472025370E+01 1.1884445433865020E+01 + 1.1907877258653702E+01 1.1931301411902883E+01 1.1954718344039859E+01 1.1978127818965328E+01 1.2001529480208459E+01 + 1.2024924017803437E+01 1.2048310642220766E+01 1.2071689325619246E+01 1.2095060758670174E+01 1.2118424092404545E+01 + 1.2141779576608990E+01 1.2165127531047698E+01 1.2188467270237243E+01 1.2211799107948751E+01 1.2235123189060232E+01 + 1.2258438891249703E+01 1.2281746694016459E+01 1.2305046467841890E+01 1.2328337721770454E+01 1.2351621043384139E+01 + 1.2374895928299036E+01 1.2398162259614274E+01 1.2421420614800283E+01 1.2444670372532588E+01 1.2467911496170862E+01 + 1.2491144486791802E+01 1.2514368726132966E+01 1.2537584270628347E+01 1.2560791460229757E+01 1.2583989781113994E+01 + 1.2607179336100183E+01 1.2630360344974559E+01 1.2653532329980491E+01 1.2676695481802835E+01 1.2699849957465743E+01 + 1.2722995191145134E+01 1.2746131531487920E+01 1.2769259070775231E+01 1.2792377204599338E+01 1.2815486303202414E+01 + 1.2838586523144237E+01 1.2861677150808561E+01 1.2884758656260647E+01 1.2907831167082524E+01 1.2930893918724761E+01 + 1.2953947533859598E+01 1.2976991844317801E+01 1.3000026341480316E+01 1.3023051670088913E+01 1.3046067425656306E+01 + 1.3069073326593918E+01 1.3092069924022399E+01 1.3115056851987479E+01 1.3138033806882374E+01 1.3161001251634758E+01 + 1.3183958994135439E+01 1.3206906589478715E+01 1.3229844525685346E+01 1.3252772701802710E+01 1.3275690543550157E+01 + 1.3298598722563947E+01 1.3321496928871499E+01 1.3344384711459600E+01 1.3367262782889036E+01 1.3390130618798327E+01 + 1.3412988009030187E+01 1.3435835487864120E+01 1.3458672719395535E+01 1.3481499372032049E+01 1.3504315893894859E+01 + 1.3527122177870499E+01 1.3549917734473878E+01 1.3572703019796636E+01 1.3595477968368790E+01 1.3618242061411769E+01 + 1.3640995829176962E+01 1.3663739087327196E+01 1.3686471401434089E+01 1.3709193276525129E+01 1.3731904551911436E+01 + 1.3754604770443112E+01 1.3777294295566083E+01 1.3799973334983582E+01 1.3822640987763661E+01 1.3845297742467581E+01 + 1.3867943998013320E+01 1.3890578876382936E+01 1.3913202862461814E+01 1.3935816403521173E+01 1.3958419161980062E+01 + 1.3981011257901885E+01 1.4003593054711608E+01 1.4026163934001417E+01 1.4048723938583795E+01 1.4071273694816988E+01 + 1.4093812345992218E+01 1.4116339879309161E+01 1.4138856848809793E+01 1.4161362797885694E+01 1.4183857591955833E+01 + 1.4206341663289074E+01 1.4228814821923036E+01 1.4251276622764777E+01 1.4273727590503288E+01 1.4296167562492005E+01 + 1.4318596069626132E+01 1.4341013457720136E+01 1.4363419652972272E+01 1.4385814284014067E+01 1.4408197683398829E+01 + 1.4430570131893729E+01 1.4452930898984029E+01 1.4475280221372708E+01 1.4497618526764731E+01 1.4519945109870742E+01 + 1.4542259850905191E+01 1.4564563247542523E+01 1.4586855114836304E+01 1.4609135109681700E+01 1.4631403809828830E+01 + 1.4653660901872696E+01 1.4675906006175818E+01 1.4698139483880331E+01 1.4720361142455090E+01 1.4742570701684816E+01 + 1.4764768466421023E+01 1.4786954808047131E+01 1.4809128977244834E+01 1.4831291154751645E+01 1.4853441569515311E+01 + 1.4875579598177705E+01 1.4897705441135013E+01 1.4919819551709180E+01 1.4941921689503619E+01 1.4964011425697542E+01 + 1.4986089194007340E+01 1.5008154606644682E+01 1.5030207503542599E+01 1.5052248205611704E+01 1.5074277110174251E+01 + 1.5096293467811712E+01 1.5118297294616047E+01 1.5140288691121754E+01 1.5162267736084303E+01 1.5184234117513382E+01 + 1.5206188322793063E+01 1.5228130306335508E+01 1.5250059157365989E+01 1.5271975298996802E+01 1.5293879280319652E+01 + 1.5315770484184604E+01 1.5337648933709209E+01 1.5359515140172720E+01 1.5381368023539242E+01 1.5403208047616680E+01 + 1.5425035588325528E+01 1.5446850757325855E+01 1.5468652604420615E+01 1.5490441231643524E+01 1.5512217426256806E+01 + 1.5533980617020889E+01 1.5555730740519291E+01 1.5577468130355461E+01 1.5599192250386805E+01 1.5620903069760057E+01 + 1.5642601205872412E+01 1.5664286630348059E+01 1.5685958171928302E+01 1.5707616383811056E+01 1.5729262131270056E+01 + 1.5750894569976911E+01 1.5772513516566342E+01 1.5794118957924798E+01 1.5815711502039807E+01 1.5837290539629691E+01 + 1.5858856380456176E+01 1.5880408804163102E+01 1.5901947532472787E+01 1.5923472861597361E+01 1.5944985382896281E+01 + 1.5966483877689102E+01 1.5987968527833218E+01 1.6009439936198362E+01 1.6030898389811156E+01 1.6052342653994501E+01 + 1.6073772877573987E+01 1.6095190093551967E+01 1.6116593882187704E+01 1.6137983374839507E+01 1.6159358987063506E+01 + 1.6180721486844607E+01 1.6202070176753434E+01 1.6223404397094775E+01 1.6244725238158885E+01 1.6266032378461773E+01 + 1.6287325593949507E+01 1.6308604396226734E+01 1.6329869802642179E+01 1.6351121198920172E+01 1.6372358566733215E+01 + 1.6393581656748530E+01 1.6414791090118413E+01 1.6435986394292854E+01 1.6457167531083940E+01 1.6478334543974061E+01 + 1.6499487581481429E+01 1.6520626322342292E+01 1.6541750954079593E+01 1.6562861466319433E+01 1.6583957794325734E+01 + 1.6605039567186505E+01 1.6626107393986661E+01 1.6647160947185114E+01 1.6668200156858756E+01 1.6689224621961053E+01 + 1.6710235285597150E+01 1.6731231428496343E+01 1.6752212860919723E+01 1.6773180086815785E+01 1.6794133239461697E+01 + 1.6815071258602121E+01 1.6835994886669145E+01 1.6856904592672258E+01 1.6877799407924829E+01 1.6898678999416799E+01 + 1.6919545015296681E+01 1.6940396527091842E+01 1.6961232260516489E+01 1.6982053912983019E+01 1.7002861526552852E+01 + 1.7023653690617373E+01 1.7044431033301155E+01 1.7065194261786623E+01 1.7085942571877954E+01 1.7106675681590332E+01 + 1.7127394419147777E+01 1.7148098190527868E+01 1.7168787105952717E+01 1.7189461377778354E+01 1.7210120135980446E+01 + 1.7230764652237145E+01 1.7251394292315243E+01 1.7272008246637199E+01 1.7292607630359580E+01 1.7313192631149633E+01 + 1.7333761781445052E+01 1.7354315936255578E+01 1.7374855689895071E+01 1.7395379987274513E+01 1.7415889019010734E+01 + 1.7436383219826467E+01 1.7456862186444798E+01 1.7477326208261061E+01 1.7497774737594156E+01 1.7518207888513079E+01 + 1.7538626736646044E+01 1.7559029706503388E+01 1.7579417036539819E+01 1.7599789933419213E+01 1.7620147338008412E+01 + 1.7640489041753142E+01 1.7660815710497488E+01 1.7681126985088667E+01 1.7701423195739590E+01 1.7721703536719133E+01 + 1.7741968353631218E+01 1.7762218869713180E+01 1.7782452792941886E+01 1.7802671396778525E+01 1.7822875243724457E+01 + 1.7843062881921277E+01 1.7863235390039858E+01 1.7883392189060451E+01 1.7903533217115310E+01 1.7923659491571101E+01 + 1.7943769412925104E+01 1.7963863760712627E+01 1.7983942966917908E+01 1.8004006305504859E+01 1.8024054290084141E+01 + 1.8044085661979565E+01 1.8064102339659520E+01 1.8084103253460793E+01 1.8104087562414090E+01 1.8124056878899108E+01 + 1.8144010423170389E+01 1.8163948133481306E+01 1.8183870109321496E+01 1.8203775505665430E+01 1.8223666308039448E+01 + 1.8243540593468925E+01 1.8263398920749665E+01 1.8283241589356386E+01 1.8303068429331379E+01 1.8322879584604852E+01 + 1.8342673815023772E+01 1.8362453253652184E+01 1.8382216325723448E+01 1.8401963263740516E+01 1.8421694482737845E+01 + 1.8441409114415702E+01 1.8461108774927045E+01 1.8480791460986342E+01 1.8500458302716435E+01 1.8520109390507432E+01 + 1.8539744265665064E+01 1.8559362968695261E+01 1.8578965147671759E+01 1.8598552171045728E+01 1.8618122285204919E+01 + 1.8637676670706767E+01 1.8657214030625262E+01 1.8676736178558443E+01 1.8696242147523577E+01 1.8715731056669835E+01 + 1.8735204413103631E+01 1.8754660990912964E+01 1.8774102049705327E+01 1.8793526093564655E+01 1.8812934060807446E+01 + 1.8832325947910714E+01 1.8851701554826551E+01 1.8871060363236595E+01 1.8890402780724251E+01 1.8909729554731271E+01 + 1.8929039388783625E+01 1.8948333341423343E+01 1.8967609612147005E+01 1.8986871074127379E+01 1.9006115128248901E+01 + 1.9025342964323723E+01 1.9044554043054532E+01 1.9063749120000679E+01 1.9082927842373874E+01 1.9102089533386895E+01 + 1.9121234658459912E+01 1.9140363581792148E+01 1.9159476003393753E+01 1.9178571526947952E+01 1.9197650466678130E+01 + 1.9216713038067919E+01 1.9235759637680420E+01 1.9254788330400512E+01 1.9273801341868332E+01 1.9292796876071705E+01 + 1.9311776905133030E+01 1.9330739217852503E+01 1.9349685122857203E+01 1.9368614406836997E+01 1.9387527449464699E+01 + 1.9406423175338428E+01 1.9425302294995795E+01 1.9444164468593858E+01 1.9463011078622074E+01 1.9481839175759724E+01 + 1.9500651621858427E+01 1.9519446309594752E+01 1.9538225549001542E+01 1.9556986885015277E+01 1.9575731670640412E+01 + 1.9594459380063931E+01 1.9613170957195369E+01 1.9631865253863438E+01 1.9650542456495732E+01 1.9669202715421537E+01 + 1.9687846718630393E+01 1.9706473342838191E+01 1.9725083256870519E+01 1.9743675319864384E+01 1.9762252093892929E+01 + 1.9780810517864051E+01 1.9799352943469003E+01 1.9817876961959026E+01 1.9836385596772207E+01 1.9854876253693845E+01 + 1.9873350447848363E+01 1.9891806671762811E+01 1.9910246663046451E+01 1.9928669696862556E+01 1.9947075287807621E+01 + 1.9965463786014364E+01 1.9983834909420075E+01 2.0002190136698488E+01 2.0020526925525356E+01 2.0038847414612320E+01 + 2.0057149717668739E+01 2.0075436463976256E+01 2.0093704907004469E+01 2.0111956723123452E+01 2.0130190532956579E+01 + 2.0148408169093955E+01 2.0166608339073338E+01 2.0184791142818639E+01 2.0202956493524425E+01 2.0221104769381839E+01 + 2.0239236616269448E+01 2.0257349917192887E+01 2.0275447034728405E+01 2.0293525457287149E+01 2.0311588628579663E+01 + 2.0329632807787185E+01 2.0347660623907650E+01 2.0365670100250302E+01 2.0383663556856092E+01 2.0401639035364393E+01 + 2.0419597280037479E+01 2.0437537681116662E+01 2.0455461330472300E+01 2.0473367761252071E+01 2.0491256565546333E+01 + 2.0509127517693180E+01 2.0526981610991211E+01 2.0544818263754827E+01 2.0562637996709132E+01 2.0580438994129175E+01 + 2.0598223716468038E+01 2.0615990155572955E+01 2.0633740391398145E+01 2.0651471757612054E+01 2.0669186381893109E+01 + 2.0686883335493590E+01 2.0704563529893118E+01 2.0722225717326062E+01 2.0739870446969963E+01 2.0757497489781798E+01 + 2.0775108178931767E+01 2.0792700153626736E+01 2.0810275805304318E+01 2.0827832056191202E+01 2.0845372721684083E+01 + 2.0862894965145902E+01 2.0880400046960023E+01 2.0897886979234901E+01 2.0915356745204232E+01 2.0932809459458639E+01 + 2.0950244359758120E+01 2.0967661302452452E+01 2.0985060522599323E+01 2.1002442635421200E+01 2.1019807376788542E+01 + 2.1037154067212693E+01 2.1054482819047088E+01 2.1071794702804951E+01 2.1089088650803639E+01 2.1106365771091149E+01 + 2.1123623441041389E+01 2.1140864638234770E+01 2.1158087916709825E+01 2.1175294108166863E+01 2.1192482042028271E+01 + 2.1209652315401470E+01 2.1226804888173426E+01 2.1243940107735835E+01 2.1261057431571015E+01 2.1278156683654451E+01 + 2.1295238618121612E+01 2.1312302565613539E+01 2.1329350034215061E+01 2.1346377772709243E+01 2.1363388796089826E+01 + 2.1380381665666405E+01 2.1397357513437189E+01 2.1414315516992659E+01 2.1431254831826347E+01 2.1448176875554008E+01 + 2.1465081013872595E+01 2.1481968126588022E+01 2.1498836457869128E+01 2.1515687640476308E+01 2.1532519879039583E+01 + 2.1549335754044556E+01 2.1566133351751347E+01 2.1582912481613281E+01 2.1599674685233182E+01 2.1616417676129434E+01 + 2.1633144493511342E+01 2.1649852466174966E+01 2.1666542641175319E+01 2.1683215011998040E+01 2.1699869260872347E+01 + 2.1716506428302381E+01 2.1733124750548249E+01 2.1749725961875040E+01 2.1766308037940995E+01 2.1782873677035450E+01 + 2.1799420875129226E+01 2.1815949465610885E+01 2.1832461102574289E+01 2.1848953638396218E+01 2.1865429643784601E+01 + 2.1881887028765707E+01 2.1898325915766844E+01 2.1914747439148730E+01 2.1931150685174707E+01 2.1947536879090357E+01 + 2.1963903992252277E+01 2.1980253154774918E+01 2.1996584612860744E+01 2.2012898173734389E+01 2.2029194609156498E+01 + 2.2045471020368424E+01 2.2061730359872634E+01 2.2077972129050412E+01 2.2094195374975470E+01 2.2110401194593688E+01 + 2.2126587920012273E+01 2.2142757086381099E+01 2.2158908697036420E+01 2.2175041620209598E+01 2.2191157114149053E+01 + 2.2207253477571019E+01 2.2223332321693601E+01 2.2239393635371854E+01 2.2255436123657962E+01 2.2271461375523593E+01 + 2.2287467056462209E+01 2.2303455498859620E+01 2.2319426990274199E+01 2.2335378360461789E+01 2.2351312696467584E+01 + 2.2367228516014809E+01 2.2383126010072353E+01 2.2399006497947003E+01 2.2414867835992087E+01 2.2430711239419267E+01 + 2.2446536279640821E+01 2.2462343272073753E+01 2.2478133341839765E+01 2.2493903503701272E+01 2.2509655866800269E+01 + 2.2525390889329689E+01 2.2541106568489315E+01 2.2556805298965813E+01 2.2572485632288398E+01 2.2588146283992042E+01 + 2.2603790141971690E+01 2.2619415794505358E+01 2.2635022799377595E+01 2.2650612137004241E+01 2.2666182172370103E+01 + 2.2681734608865888E+01 2.2697269649883651E+01 2.2712785223195709E+01 2.2728283323208831E+01 2.2743762746087757E+01 + 2.2759223465429258E+01 2.2774667457402352E+01 2.2790092406677797E+01 2.2805498449080002E+01 2.2820886964035836E+01 + 2.2836256804488745E+01 2.2851608828526214E+01 2.2866942945483249E+01 2.2882257658992167E+01 2.2897554358288502E+01 + 2.2912833546800083E+01 2.2928093734584664E+01 2.2943336271278863E+01 2.2958560334967203E+01 2.2973764830293476E+01 + 2.2988952516702096E+01 2.3004122275158615E+01 2.3019272176492056E+01 2.3034404828547711E+01 2.3049518812858942E+01 + 2.3064613764662923E+01 2.3079692154330008E+01 2.3094751202479593E+01 2.3109791161151605E+01 2.3124813829503712E+01 + 2.3139817702567314E+01 2.3154803425266085E+01 2.3169771419908759E+01 2.3184720091726696E+01 2.3199649974416069E+01 + 2.3214562806669178E+01 2.3229457301570175E+01 2.3244332314115404E+01 2.3259189905657376E+01 2.3274028642483660E+01 + 2.3288848370433950E+01 2.3303651411670959E+01 2.3318435229305983E+01 2.3333199847789921E+01 2.3347946879239167E+01 + 2.3362675648266752E+01 2.3377385624956251E+01 2.3392077825390508E+01 2.3406751715700420E+01 2.3421405409366049E+01 + 2.3436042142587308E+01 2.3450661304472355E+01 2.3465260591633729E+01 2.3479841722626240E+01 2.3494404872986586E+01 + 2.3508949044920161E+01 2.3523475162504788E+01 2.3537983837977059E+01 2.3552472545548564E+01 2.3566942613248724E+01 + 2.3581395340992454E+01 2.3595829891588696E+01 2.3610244931456545E+01 2.3624642229264474E+01 2.3639021272548320E+01 + 2.3653380318979416E+01 2.3667722387406720E+01 2.3682046539972941E+01 2.3696351089515154E+01 2.3710636744800215E+01 + 2.3724904996757743E+01 2.3739154674424427E+01 2.3753385468057580E+01 2.3767598284748335E+01 2.3781792764942580E+01 + 2.3795967126958011E+01 2.3810124405286860E+01 2.3824264132269487E+01 2.3838384086017548E+01 2.3852485045684421E+01 + 2.3866568359615172E+01 2.3880633463874513E+01 2.3894679461462331E+01 2.3908707333412877E+01 2.3922717120602336E+01 + 2.3936707265093727E+01 2.3950678880286894E+01 2.3964633536299790E+01 2.3978569357052830E+01 2.3992485262433565E+01 + 2.4006383249966873E+01 2.4020263368192612E+01 2.4034124812789120E+01 2.4047967298420616E+01 2.4061791843547812E+01 + 2.4075597827129318E+01 2.4089384117675696E+01 2.4103152726044485E+01 2.4116903941064425E+01 2.4130635689240577E+01 + 2.4144347910106152E+01 2.4158042230431299E+01 2.4171719250024157E+01 2.4185376550334684E+01 2.4199015273477851E+01 + 2.4212635951906286E+01 2.4226238384458618E+01 2.4239820698328561E+01 2.4253385716202988E+01 2.4266932855232824E+01 + 2.4280461026693025E+01 2.4293969155421482E+01 2.4307459497289617E+01 2.4320932524498250E+01 2.4334386541505129E+01 + 2.4347820975881707E+01 2.4361237288255804E+01 2.4374635655453300E+01 2.4388014775834712E+01 2.4401375555056710E+01 + 2.4414718120505036E+01 2.4428042379228444E+01 2.4441347122862993E+01 2.4454632877448724E+01 2.4467901432326393E+01 + 2.4481151911929555E+01 2.4494382738647019E+01 2.4507594116440352E+01 2.4520787718841923E+01 2.4533963982877520E+01 + 2.4547120710249406E+01 2.4560258273023706E+01 2.4573377754911565E+01 2.4586479111214995E+01 2.4599561047818188E+01 + 2.4612624778209664E+01 2.4625670304930793E+01 2.4638697512534119E+01 2.4651705582843146E+01 2.4664693888738277E+01 + 2.4677664955750615E+01 2.4690618305503197E+01 2.4703552363717986E+01 2.4716466696423321E+01 2.4729362697151807E+01 + 2.4742241111554375E+01 2.4755101733256712E+01 2.4767941866521426E+01 2.4780763692213664E+01 2.4793567331181890E+01 + 2.4806352736076242E+01 2.4819119223024039E+01 2.4831866901599025E+01 2.4844596299721474E+01 2.4857307430252856E+01 + 2.4869999484313883E+01 2.4882672150347407E+01 2.4895327233696182E+01 2.4907964206534754E+01 2.4920582677547802E+01 + 2.4933180859747818E+01 2.4945760550053571E+01 2.4958322821485687E+01 2.4970867187292122E+01 2.4983392373619289E+01 + 2.4995897435935667E+01 2.5008384425183245E+01 2.5020853492428884E+01 2.5033304904734297E+01 2.5045736792357584E+01 + 2.5058149135104884E+01 2.5070543394237237E+01 2.5082919449676950E+01 2.5095277418308367E+01 2.5107615966988771E+01 + 2.5119935768452642E+01 2.5132237273738586E+01 2.5144520459694750E+01 2.5156784844595073E+01 2.5169030040267653E+01 + 2.5181257224444213E+01 2.5193465936150009E+01 2.5205656267142043E+01 2.5217827434626152E+01 2.5229979074111387E+01 + 2.5242113316475876E+01 2.5254229274001791E+01 2.5266326759824221E+01 2.5278404566606184E+01 2.5290463176684778E+01 + 2.5302504122736181E+01 2.5314527222785511E+01 2.5326531765778014E+01 2.5338516870295170E+01 2.5350482303631853E+01 + 2.5362429753926072E+01 2.5374359640720918E+01 2.5386271442285548E+01 2.5398163840417261E+01 2.5410036300257410E+01 + 2.5421890508451881E+01 2.5433726859959823E+01 2.5445545502244123E+01 2.5457345304641038E+01 2.5469124997469738E+01 + 2.5480886144891812E+01 2.5492629010768528E+01 2.5504354143502326E+01 2.5516061266377434E+01 2.5527748528842157E+01 + 2.5539416520542314E+01 2.5551066229056900E+01 2.5562697754636869E+01 2.5574311535915875E+01 2.5585906548966136E+01 + 2.5597481718036306E+01 2.5609038259005601E+01 2.5620576470308951E+01 2.5632096479916676E+01 2.5643598998954733E+01 + 2.5655081626748849E+01 2.5666545112739623E+01 2.5677990149300477E+01 2.5689416794202774E+01 2.5700825339008382E+01 + 2.5712216038986224E+01 2.5723586943648211E+01 2.5734938740131295E+01 2.5746272188169510E+01 2.5757587248149694E+01 + 2.5768884402960037E+01 2.5780163313356155E+01 2.5791422383711026E+01 2.5802662608506111E+01 2.5813884417408879E+01 + 2.5825087855564675E+01 2.5836273442559015E+01 2.5847440956884370E+01 2.5858588200013589E+01 2.5869716769040668E+01 + 2.5880826908331692E+01 2.5891918734948419E+01 2.5902992689970944E+01 2.5914048521340753E+01 2.5925084568455258E+01 + 2.5936101354006979E+01 2.5947099805707737E+01 2.5958079851365856E+01 2.5969042290943506E+01 2.5979986592166835E+01 + 2.5990911378836103E+01 2.6001816510621666E+01 2.6012703238996615E+01 2.6023571683746820E+01 2.6034422347596266E+01 + 2.6045255034249656E+01 2.6056069041277876E+01 2.6066863695336593E+01 2.6077639519287668E+01 2.6088397472716945E+01 + 2.6099137865140968E+01 2.6109860407881445E+01 2.6120564610943493E+01 2.6131250224353661E+01 2.6141916024987697E+01 + 2.6152563834666442E+01 2.6163194114804906E+01 2.6173806614041602E+01 2.6184400655715276E+01 2.6194976387895888E+01 + 2.6205533471833871E+01 2.6216071389083158E+01 2.6226591453981928E+01 2.6237093823579666E+01 2.6247577737413813E+01 + 2.6258043335179977E+01 2.6268490678804902E+01 2.6278919830723325E+01 2.6289330223879002E+01 2.6299722409907446E+01 + 2.6310096177641732E+01 2.6320451612391885E+01 2.6330788793972225E+01 2.6341107898101352E+01 2.6351409374749132E+01 + 2.6361692614328508E+01 2.6371956335521002E+01 2.6382201590750928E+01 2.6392428632867563E+01 2.6402637487895149E+01 + 2.6412828800385110E+01 2.6423002364566280E+01 2.6433157507125603E+01 2.6443293724643613E+01 2.6453410556522787E+01 + 2.6463509287999912E+01 2.6473590305747237E+01 2.6483653710030072E+01 2.6493698736567453E+01 2.6503725365251391E+01 + 2.6513733704498989E+01 2.6523723443233095E+01 2.6533694478311965E+01 2.6543647612272377E+01 2.6553582558995789E+01 + 2.6563499082883212E+01 2.6573397284379340E+01 2.6583277242082897E+01 2.6593139206418513E+01 2.6602983850232594E+01 + 2.6612809648723303E+01 2.6622615954955741E+01 2.6632404046455893E+01 2.6642173888402017E+01 2.6651925752165234E+01 + 2.6661660035201603E+01 2.6671376309862154E+01 2.6681074138391846E+01 2.6690753613491079E+01 2.6700414306846945E+01 + 2.6710055975231995E+01 2.6719680082777362E+01 2.6729286320187573E+01 2.6738874106139843E+01 2.6748443513050287E+01 + 2.6757994617306291E+01 2.6767527531639558E+01 2.6777042682574198E+01 2.6786540281054087E+01 2.6796018791821574E+01 + 2.6805478041559816E+01 2.6814919136744383E+01 2.6824341988206584E+01 2.6833746975287195E+01 2.6843134405227467E+01 + 2.6852503594189123E+01 2.6861854367890619E+01 2.6871186785904534E+01 2.6880500917013226E+01 2.6889796738476836E+01 + 2.6899074000959686E+01 2.6908333351039087E+01 2.6917574189693632E+01 2.6926796666235639E+01 2.6936000857942158E+01 + 2.6945186876120211E+01 2.6954355220651916E+01 2.6963505835661206E+01 2.6972638070578025E+01 2.6981751897065774E+01 + 2.6990847363269296E+01 2.6999923448001876E+01 2.7008981554127690E+01 2.7018022300973012E+01 2.7027044748485213E+01 + 2.7036048749157512E+01 2.7045034397405562E+01 2.7054001771359665E+01 2.7062951106773831E+01 2.7071882816058512E+01 + 2.7080796624097694E+01 2.7089692008863757E+01 2.7098569009945141E+01 2.7107426879802368E+01 2.7116266251380988E+01 + 2.7125087769904550E+01 2.7133891969765045E+01 2.7142677671078779E+01 2.7151444978691256E+01 2.7160193950136573E+01 + 2.7168924655212695E+01 2.7177637362367562E+01 2.7186332521945047E+01 2.7195009680055477E+01 2.7203668397583431E+01 + 2.7212308731757691E+01 2.7220930556847797E+01 2.7229533538878826E+01 2.7238118660536340E+01 2.7246686275697829E+01 + 2.7255235453704337E+01 2.7263766266073908E+01 2.7272278753088354E+01 2.7280772980043775E+01 2.7289249182335478E+01 + 2.7297707899290494E+01 2.7306148644763351E+01 2.7314570920403884E+01 2.7322974833176954E+01 2.7331360460785891E+01 + 2.7339727880208365E+01 2.7348077626231742E+01 2.7356409236629155E+01 2.7364722155081985E+01 2.7373016694003500E+01 + 2.7381292946474101E+01 2.7389550951337768E+01 2.7397790893451980E+01 2.7406013255507808E+01 2.7414217872434619E+01 + 2.7422403988631032E+01 2.7430571747537950E+01 2.7438721221685022E+01 2.7446852488127590E+01 2.7454966014895156E+01 + 2.7463061947766406E+01 2.7471139673843055E+01 2.7479198997939910E+01 2.7487240013735139E+01 2.7495262790787343E+01 + 2.7503267349667603E+01 2.7511253684362210E+01 2.7519222431713359E+01 2.7527172694970410E+01 2.7535104633775934E+01 + 2.7543018286127833E+01 2.7550913717602452E+01 2.7558791193847647E+01 2.7566651207625441E+01 2.7574493276968344E+01 + 2.7582316906294466E+01 2.7590122209477116E+01 2.7597909275272112E+01 2.7605678187078421E+01 2.7613429370041850E+01 + 2.7621162968498417E+01 2.7628878383179163E+01 2.7636575431239635E+01 2.7644254200182161E+01 2.7651914739122844E+01 + 2.7659557126302136E+01 2.7667181948364057E+01 2.7674789255578176E+01 2.7682378136812634E+01 2.7689948664666183E+01 + 2.7697500573577464E+01 2.7705034128299584E+01 2.7712549683421468E+01 2.7720047909459467E+01 2.7727528204934107E+01 + 2.7734990111947337E+01 2.7742433737199597E+01 2.7749859155098775E+01 2.7757266421011817E+01 2.7764655796810565E+01 + 2.7772027695409296E+01 2.7779381713188052E+01 2.7786717309036788E+01 2.7794034632662150E+01 2.7801333746438807E+01 + 2.7808614718013636E+01 2.7815878041206538E+01 2.7823123865541582E+01 2.7830351519325504E+01 2.7837560852487897E+01 + 2.7844751939480233E+01 2.7851924861030383E+01 2.7859079734502430E+01 2.7866216943632796E+01 2.7873336617528057E+01 + 2.7880438119090215E+01 2.7887521303762739E+01 2.7894586269547190E+01 2.7901633064884830E+01 2.7908661755158224E+01 + 2.7915673122248094E+01 2.7922666763316911E+01 2.7929642142793799E+01 2.7936599248605795E+01 2.7943538153369950E+01 + 2.7950458921855880E+01 2.7957361735884195E+01 2.7964247052237482E+01 2.7971114770779074E+01 2.7977964164552144E+01 + 2.7984795307901976E+01 2.7991608283767331E+01 2.7998403137151865E+01 2.8005179924728054E+01 2.8011939590040924E+01 + 2.8018681378990532E+01 2.8025404904056085E+01 2.8032110194538230E+01 2.8038797314742439E+01 2.8045466331236113E+01 + 2.8052117441404445E+01 2.8058751194940921E+01 2.8065367304771918E+01 2.8071965043481519E+01 2.8078544574428872E+01 + 2.8085105979841838E+01 2.8091649311839948E+01 2.8098174608167781E+01 2.8104682876501581E+01 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 2.5594311267786218E-01 2.5495341879195715E-01 2.5395813592853700E-01 2.5295744419580829E-01 2.5195152219934613E-01 + 2.5094054868017845E-01 2.4992469719804516E-01 2.4890414120589480E-01 2.4787905313387734E-01 2.4684960382514973E-01 + 2.4581596251717383E-01 2.4477829866406964E-01 2.4373677572091523E-01 2.4269155792462280E-01 2.4164280798804819E-01 + 2.4059068695437713E-01 2.3953535441888610E-01 2.3847696931893786E-01 2.3741568536881844E-01 2.3635165686797704E-01 + 2.3528503640723569E-01 2.3421597485172990E-01 2.3314462186905888E-01 2.3207112530344362E-01 2.3099562913666860E-01 + 2.2991827732126557E-01 2.2883921206412655E-01 2.2775857382142647E-01 2.2667650205260745E-01 2.2559313345879065E-01 + 2.2450860204040987E-01 2.2342304125421192E-01 2.2233658279483753E-01 2.2124935659702366E-01 2.2016149177019603E-01 + 2.1907311392949008E-01 2.1798434697374774E-01 2.1689531382783531E-01 2.1580613566355195E-01 2.1471693189560245E-01 + 2.1362782125089730E-01 2.1253891842063236E-01 2.1145033718880049E-01 2.1036219001836695E-01 2.0927458764283000E-01 + 2.0818763906355009E-01 2.0710145269280453E-01 2.0601613254688475E-01 2.0493178237050161E-01 2.0384850433172319E-01 + 2.0276639889899872E-01 2.0168556495024850E-01 2.0060610043710742E-01 1.9952809932447221E-01 1.9845165538281448E-01 + 1.9737686072087260E-01 1.9630380579473697E-01 1.9523257969355282E-01 1.9416326992614705E-01 1.9309596099995058E-01 + 1.9203073687648073E-01 1.9096767991115104E-01 1.8990687086092375E-01 1.8884838930058626E-01 1.8779231274537733E-01 + 1.8673871651997928E-01 1.8568767512715023E-01 1.8463926152457397E-01 1.8359354714132811E-01 1.8255060236421231E-01 + 1.8151049520905835E-01 1.8047329213815463E-01 1.7943905859268489E-01 1.7840785853745833E-01 1.7737975447844739E-01 + 1.7635480799590811E-01 1.7533307811910540E-01 1.7431462281870019E-01 1.7329949890427437E-01 1.7228776178656935E-01 + 1.7127946549050049E-01 1.7027466320491466E-01 1.6927340550318506E-01 1.6827574227070480E-01 1.6728172214393805E-01 + 1.6629139244124064E-01 1.6530479920295499E-01 1.6432198758298633E-01 1.6334300033173402E-01 1.6236787964449984E-01 + 1.6139666646707709E-01 1.6042940050708152E-01 1.5946612034996197E-01 1.5850686343703496E-01 1.5755166538088494E-01 + 1.5660056109407589E-01 1.5565358431998927E-01 1.5471076764614358E-01 1.5377214266419023E-01 1.5283773968153574E-01 + 1.5190758761635520E-01 1.5098171459245566E-01 1.5006014764709830E-01 1.4914291274771119E-01 1.4823003495927575E-01 + 1.4732153802437772E-01 1.4641744461799375E-01 1.4551777657063072E-01 1.4462255471466284E-01 1.4373179888784526E-01 + 1.4284552810718584E-01 1.4196376010227141E-01 1.4108651175954415E-01 1.4021379911242612E-01 1.3934563727625482E-01 + 1.3848204045453247E-01 1.3762302208404306E-01 1.3676859442231459E-01 1.3591876901861910E-01 1.3507355659457373E-01 + 1.3423296703188775E-01 1.3339700938472859E-01 1.3256569197102602E-01 1.3173902209597679E-01 1.3091700641973036E-01 + 1.3009965082522112E-01 1.2928696043284116E-01 1.2847893962004006E-01 1.2767559202933762E-01 1.2687692052184346E-01 + 1.2608292730210316E-01 1.2529361387385943E-01 1.2450898105290657E-01 1.2372902897637751E-01 1.2295375710685717E-01 + 1.2218316427971826E-01 1.2141724868906825E-01 1.2065600790104446E-01 1.1989943886481817E-01 1.1914753789759659E-01 + 1.1840030075745137E-01 1.1765772265396607E-01 1.1691979819687870E-01 1.1618652143710602E-01 1.1545788587889250E-01 + 1.1473388442583271E-01 1.1401450957171169E-01 1.1329975328793374E-01 1.1258960700811055E-01 1.1188406166876110E-01 + 1.1118310772812764E-01 1.1048673506473417E-01 1.0979493332195800E-01 1.0910769160511061E-01 1.0842499855240770E-01 + 1.0774684237050433E-01 1.0707321084696948E-01 1.0640409120643493E-01 1.0573947062403663E-01 1.0507933569360804E-01 + 1.0442367262033561E-01 1.0377246723934880E-01 1.0312570499191648E-01 1.0248337088596321E-01 1.0184544989891353E-01 + 1.0121192647321434E-01 1.0058278472252756E-01 9.9958008445816413E-02 9.9337581060276223E-02 9.8721485714172372E-02 + 9.8109705486905452E-02 9.7502222993805662E-02 9.6899020574521044E-02 9.6300080301042867E-02 9.5705383875159852E-02 + 9.5114912903465063E-02 9.4528648856717287E-02 9.3946572821207400E-02 9.3368665655113897E-02 9.2794907996116671E-02 + 9.2225280113177557E-02 9.1659762362750821E-02 9.1098334877234802E-02 9.0540977489152408E-02 8.9987669846548171E-02 + 8.9438391420361862E-02 8.8893121310920281E-02 8.8351838888393930E-02 8.7814523198028127E-02 8.7281153071434567E-02 + 8.6751707195874370E-02 8.6226164121137969E-02 8.5704502022711612E-02 8.5186699522743409E-02 8.4672734811406122E-02 + 8.4162585950759719E-02 8.3656230895122682E-02 8.3153647462780644E-02 8.2654813231833227E-02 8.2159706186902756E-02 + 8.1668303910753887E-02 8.1180583906237627E-02 8.0696523601998082E-02 8.0216100274470570E-02 7.9739291150778172E-02 + 7.9266073727324374E-02 7.8796425187790842E-02 7.8330322666540678E-02 7.7867743253575747E-02 7.7408663869543926E-02 + 7.6953061570069439E-02 7.6500913539333512E-02 7.6052196736311445E-02 7.5606888098534136E-02 7.5164964545510929E-02 + 7.4726402810404727E-02 7.4291179935107046E-02 7.3859272951031577E-02 7.3430658748902033E-02 7.3005314222132703E-02 + 7.2583216270366249E-02 7.2164341590313305E-02 7.1748667348497303E-02 7.1336170566545565E-02 7.0926828205945064E-02 + 7.0520617251981707E-02 7.0117514717731630E-02 6.9717497398380596E-02 6.9320542704661328E-02 6.8926627776851740E-02 + 6.8535729769231293E-02 6.8147825879308316E-02 6.7762893324866305E-02 6.7380909195799560E-02 6.7001851173627072E-02 + 6.6625696656055486E-02 6.6252423097403826E-02 6.5882008012014104E-02 6.5514428903034244E-02 6.5149663325216670E-02 + 6.4787689253396716E-02 6.4428484463681310E-02 6.4072026803787652E-02 6.3718294195110839E-02 6.3367264519775313E-02 + 6.3018915873803455E-02 6.2673226613538940E-02 6.2330174975457259E-02 6.1989739280017692E-02 6.1651897933649877E-02 + 6.1316629277353624E-02 6.0983912012332914E-02 6.0653724952191040E-02 6.0326046863265877E-02 6.0000856606154077E-02 + 5.9678133137540286E-02 5.9357855326426776E-02 5.9040002530106210E-02 5.8724554084407472E-02 5.8411489343181508E-02 + 5.8100787763661198E-02 5.7792428907398642E-02 5.7486392228396438E-02 5.7182657780795738E-02 5.6881205476596308E-02 + 5.6582015305440922E-02 5.6285067366418161E-02 5.5990341856421939E-02 5.5697818903845057E-02 5.5407479248016159E-02 + 5.5119303436662506E-02 5.4833272132198199E-02 5.4549366112795900E-02 5.4267566218629479E-02 5.3987853370806214E-02 + 5.3710208935547656E-02 5.3434614158839620E-02 5.3161050405676868E-02 5.2889499160666813E-02 5.2619941939521568E-02 + 5.2352360469541059E-02 5.2086736774029196E-02 5.1823052819899941E-02 5.1561290695933321E-02 5.1301432613786876E-02 + 5.1043460788741661E-02 5.0787357760706399E-02 5.0533106232769541E-02 5.0280688908325398E-02 5.0030088614534091E-02 + 4.9781288302996010E-02 4.9534270906148502E-02 4.9289019776324869E-02 4.9045518312890272E-02 4.8803749964466528E-02 + 4.8563698304891774E-02 4.8325347032960590E-02 4.8088679808772149E-02 4.7853680792318269E-02 4.7620334088748412E-02 + 4.7388623895824052E-02 4.7158534536252329E-02 4.6930050453745521E-02 4.6703156053970955E-02 4.6477836281463888E-02 + 4.6254075956659355E-02 4.6031860024635496E-02 4.5811173554579351E-02 4.5592001704308077E-02 4.5374329707907231E-02 + 4.5158143198163678E-02 4.4943427737935984E-02 4.4730169013534861E-02 4.4518352834367461E-02 4.4307965069681605E-02 + 4.4098991762789384E-02 4.3891419232113552E-02 4.3685233774063470E-02 4.3480421806363440E-02 4.3276969867912747E-02 + 4.3074864532958980E-02 4.2874092632171630E-02 4.2674641163560581E-02 4.2476497144117421E-02 4.2279647709894674E-02 + 4.2084080115539893E-02 4.1889781630752722E-02 4.1696739848912645E-02 4.1504942438157152E-02 4.1314377120436133E-02 + 4.1125031734331373E-02 4.0936894233834752E-02 4.0749952571100138E-02 4.0564195075966439E-02 4.0379610074233359E-02 + 4.0196185975164056E-02 4.0013911301285551E-02 3.9832774687323665E-02 3.9652764752233442E-02 3.9473870534890522E-02 + 3.9296081003864100E-02 3.9119385235759710E-02 3.8943772416783637E-02 3.8769231820070194E-02 3.8595752778523833E-02 + 3.8423324946830498E-02 3.8251937940883420E-02 3.8081581482902471E-02 3.7912245400901046E-02 3.7743919586881322E-02 + 3.7576594061341437E-02 3.7410259071939927E-02 3.7244904861216406E-02 3.7080521774106354E-02 3.6917100257239266E-02 + 3.6754630801773637E-02 3.6593104083937102E-02 3.6432510925787386E-02 3.6272842172653030E-02 3.6114088768323005E-02 + 3.5956241754127906E-02 3.5799292199297790E-02 3.5643231403675091E-02 3.5488050744102474E-02 3.5333741644143372E-02 + 3.5180295621724263E-02 3.5027704288091058E-02 3.4875959268814191E-02 3.4725052455539938E-02 3.4574975758997095E-02 + 3.4425721155965289E-02 3.4277280713373950E-02 3.4129646587470655E-02 3.3982810937414364E-02 3.3836766215173085E-02 + 3.3691504843876070E-02 3.3547019328181923E-02 3.3403302258916939E-02 3.3260346299971565E-02 3.3118144156236991E-02 + 3.2976688773982799E-02 3.2835973078376816E-02 3.2695990076784115E-02 3.2556732858309734E-02 3.2418194567545432E-02 + 3.2280368436838187E-02 3.2143247871271069E-02 3.2006826277627118E-02 3.1871097140772839E-02 3.1736054022478546E-02 + 3.1601690525846472E-02 3.1468000378858274E-02 3.1334977424348660E-02 3.1202615525521355E-02 3.1070908619283341E-02 + 3.0939850715805281E-02 3.0809435853641910E-02 3.0679658225914903E-02 3.0550512091892478E-02 3.0421991746345318E-02 + 3.0294091553781370E-02 3.0166805947857964E-02 3.0040129380365686E-02 2.9914056479798588E-02 2.9788581900841514E-02 + 2.9663700345479174E-02 2.9539406581619746E-02 2.9415695442282955E-02 2.9292561770133289E-02 2.9170000601016856E-02 + 2.9048006963649470E-02 2.8926575943628432E-02 2.8805702688725336E-02 2.8685382401884615E-02 2.8565610312116234E-02 + 2.8446381818211353E-02 2.8327692307836310E-02 2.8209537227190863E-02 2.8091912080831165E-02 2.7974812415749881E-02 + 2.7858233835290337E-02 2.7742172065707366E-02 2.7626622836577647E-02 2.7511581932225880E-02 2.7397045191665480E-02 + 2.7283008485818622E-02 2.7169467765789424E-02 2.7056419066088053E-02 2.6943858436552479E-02 2.6831781978015560E-02 + 2.6720185842456820E-02 2.6609066204941263E-02 2.6498419339124370E-02 2.6388241569363740E-02 2.6278529244553501E-02 + 2.6169278761330923E-02 2.6060486563969743E-02 2.5952149112559053E-02 2.5844262979341209E-02 2.5736824760518279E-02 + 2.5629831083876564E-02 2.5523278621912848E-02 2.5417164091198256E-02 2.5311484218346912E-02 2.5206235852017551E-02 + 2.5101415842326683E-02 2.4997021076843436E-02 2.4893048484637425E-02 2.4789495033614176E-02 2.4686357705826393E-02 + 2.4583633598034425E-02 2.4481319799865623E-02 2.4379413440076891E-02 2.4277911686329326E-02 2.4176811735929383E-02 + 2.4076110819890643E-02 2.3975806252490219E-02 2.3875895350111396E-02 2.3776375465348932E-02 2.3677243986823259E-02 + 2.3578498325458042E-02 2.3480135940852524E-02 2.3382154349808799E-02 2.3284551078873662E-02 2.3187323687744763E-02 + 2.3090469769062823E-02 2.2993986932522744E-02 2.2897872847151939E-02 2.2802125218296432E-02 2.2706741766075952E-02 + 2.2611720241618675E-02 2.2517058426635005E-02 2.2422754114055029E-02 2.2328805165262280E-02 2.2235209460101268E-02 + 2.2141964897369467E-02 2.2049069404800965E-02 2.1956520937659475E-02 2.1864317459039408E-02 2.1772457005897590E-02 + 2.1680937619237003E-02 2.1589757362742205E-02 2.1498914325986905E-02 2.1408406623979071E-02 2.1318232378038152E-02 + 2.1228389783798134E-02 2.1138877031569778E-02 2.1049692336160955E-02 2.0960833936225338E-02 2.0872300089909184E-02 + 2.0784089073666370E-02 2.0696199218232375E-02 2.0608628854505789E-02 2.0521376335916254E-02 2.0434440037530876E-02 + 2.0347818349203569E-02 2.0261509688157622E-02 2.0175512509590165E-02 2.0089825273068376E-02 2.0004446458513417E-02 + 1.9919374566070774E-02 1.9834608105977126E-02 1.9750145623606358E-02 1.9665985687959728E-02 1.9582126876110908E-02 + 1.9498567783613103E-02 1.9415307024438694E-02 1.9332343219271457E-02 1.9249675029178168E-02 1.9167301127559783E-02 + 1.9085220198408588E-02 1.9003430942648971E-02 1.8921932077651738E-02 1.8840722325102508E-02 1.8759800450504946E-02 + 1.8679165222612953E-02 1.8598815422464093E-02 1.8518749846755705E-02 1.8438967307017690E-02 1.8359466616365464E-02 + 1.8280246634837429E-02 1.8201306217788656E-02 1.8122644234606584E-02 1.8044259568240722E-02 1.7966151113446956E-02 + 1.7888317773303936E-02 1.7810758486097353E-02 1.7733472188055027E-02 1.7656457828031259E-02 1.7579714367689073E-02 + 1.7503240776538889E-02 1.7427036039019458E-02 1.7351099163737883E-02 1.7275429160127052E-02 1.7200025048869045E-02 + 1.7124885862272038E-02 1.7050010637759083E-02 1.6975398432317278E-02 1.6901048318409186E-02 1.6826959370994047E-02 + 1.6753130675631604E-02 1.6679561328110607E-02 1.6606250426729172E-02 1.6533197093792119E-02 1.6460400458778446E-02 + 1.6387859655897154E-02 1.6315573828606673E-02 1.6243542129517664E-02 1.6171763712041556E-02 1.6100237756222817E-02 + 1.6028963442927008E-02 1.5957939959380503E-02 1.5887166500714818E-02 1.5816642270496048E-02 1.5746366471300649E-02 + 1.5676338334443481E-02 1.5606557087114385E-02 1.5537021963301201E-02 1.5467732204671481E-02 1.5398687058670067E-02 + 1.5329885775491657E-02 1.5261327628288133E-02 1.5193011886486685E-02 1.5124937826119390E-02 1.5057104729728750E-02 + 1.4989511883482902E-02 1.4922158581013752E-02 1.4855044131364051E-02 1.4788167841797982E-02 1.4721529025465604E-02 + 1.4655127001220920E-02 1.4588961089708462E-02 1.4523030622488765E-02 1.4457334940584191E-02 1.4391873384600637E-02 + 1.4326645300340692E-02 1.4261650038870916E-02 1.4196886950957967E-02 1.4132355401667915E-02 1.4068054760112129E-02 + 1.4003984396335418E-02 1.3940143684847443E-02 1.3876532004744951E-02 1.3813148733421387E-02 1.3749993265376429E-02 + 1.3687064994246639E-02 1.3624363315666223E-02 1.3561887629320936E-02 1.3499637338911713E-02 1.3437611845216598E-02 + 1.3375810568031025E-02 1.3314232922510641E-02 1.3252878326750603E-02 1.3191746202428098E-02 1.3130835973546452E-02 + 1.3070147063469846E-02 1.3009678911996791E-02 1.2949430953637025E-02 1.2889402625840343E-02 1.2829593369061112E-02 + 1.2770002624805899E-02 1.2710629837404397E-02 1.2651474462299523E-02 1.2592535951076999E-02 1.2533813757986519E-02 + 1.2475307339759109E-02 1.2417016152755473E-02 1.2358939659394897E-02 1.2301077328544095E-02 1.2243428626388565E-02 + 1.2185993021680332E-02 1.2128769984969482E-02 1.2071758985333959E-02 1.2014959500667966E-02 1.1958371011193519E-02 + 1.1901992995731336E-02 1.1845824935038727E-02 1.1789866311575971E-02 1.1734116605104702E-02 1.1678575306820925E-02 + 1.1623241906548556E-02 1.1568115893615040E-02 1.1513196758948199E-02 1.1458483995188395E-02 1.1403977090901983E-02 + 1.1349675548692005E-02 1.1295578866208430E-02 1.1241686541648721E-02 1.1187998074566529E-02 1.1134512965423326E-02 + 1.1081230711521832E-02 1.1028150823895674E-02 1.0975272806876331E-02 1.0922596166174251E-02 1.0870120408351919E-02 + 1.0817845039767442E-02 1.0765769567066940E-02 1.0713893505924482E-02 1.0662216367159623E-02 1.0610737662335872E-02 + 1.0559456904082812E-02 1.0508373603196473E-02 1.0457487274233682E-02 1.0406797436782717E-02 1.0356303606545344E-02 + 1.0306005300150590E-02 1.0255902034884603E-02 1.0205993325349130E-02 1.0156278692418379E-02 1.0106757658766993E-02 + 1.0057429744150687E-02 1.0008294469060510E-02 9.9593513546439114E-03 9.9105999181754532E-03 9.8620396862327507E-03 + 9.8136701834536343E-03 9.7654909329245570E-03 9.7175014581991313E-03 9.6697012832737527E-03 9.6220899276382669E-03 + 9.5746669224514927E-03 9.5274317938006739E-03 9.4803840672725952E-03 9.4335232688125357E-03 9.3868489244878870E-03 + 9.3403605559117496E-03 9.2940576974596349E-03 9.2479398763638219E-03 9.2020066200782721E-03 9.1562574563856802E-03 + 9.1106919120352414E-03 9.0653095127191125E-03 9.0201097929831758E-03 8.9750922815203370E-03 8.9302565072227821E-03 + 8.8856019991794613E-03 8.8411282845051974E-03 8.7968348923701655E-03 8.7527213571143309E-03 8.7087872085288235E-03 + 8.6650319765441720E-03 8.6214551912094147E-03 8.5780563796610948E-03 8.5348350741095928E-03 8.4917908084485762E-03 + 8.4489231132397792E-03 8.4062315191336563E-03 8.3637155568959762E-03 8.3213747534517449E-03 8.2792086436894504E-03 + 8.2372167608717687E-03 8.1953986360869622E-03 8.1537538005301731E-03 8.1122817854460683E-03 8.0709821174449695E-03 + 8.0298543337681393E-03 7.9888979669414176E-03 7.9481125484611448E-03 7.9074976098884309E-03 7.8670526828236494E-03 + 7.8267772934896805E-03 7.7866709812753933E-03 7.7467332779296034E-03 7.7069637152435075E-03 7.6673618250791007E-03 + 7.6279271382771879E-03 7.5886591837959518E-03 7.5495574998752533E-03 7.5106216185456143E-03 7.4718510718876727E-03 + 7.4332453919977119E-03 7.3948041090619709E-03 7.3565267545778823E-03 7.3184128657418955E-03 7.2804619748743950E-03 + 7.2426736143364461E-03 7.2050473165208642E-03 7.1675826110078377E-03 7.1302790318026272E-03 7.0931361151484905E-03 + 7.0561533937022608E-03 7.0193304001599085E-03 6.9826666673165529E-03 6.9461617242468077E-03 6.9098151074349721E-03 + 6.8736263523263199E-03 6.8375949919907489E-03 6.8017205595976953E-03 6.7660025883886765E-03 6.7304406071740418E-03 + 6.6950341548668753E-03 6.6597827662962421E-03 6.6246859751096223E-03 6.5897433150454744E-03 6.5549543199584026E-03 + 6.5203185185657986E-03 6.4858354522646187E-03 6.4515046554722115E-03 6.4173256625466232E-03 6.3832980079844464E-03 + 6.3494212255761759E-03 6.3156948466748346E-03 6.2821184127014196E-03 6.2486914587545194E-03 6.2154135200658822E-03 + 6.1822841320750953E-03 6.1493028285532899E-03 6.1164691441613515E-03 6.0837826200104096E-03 6.0512427922505014E-03 + 6.0188491972180506E-03 5.9866013714604009E-03 5.9544988490418021E-03 5.9225411679858049E-03 5.8907278693587205E-03 + 5.8590584906000436E-03 5.8275325693411756E-03 5.7961496434865735E-03 5.7649092476315276E-03 5.7338109232888557E-03 + 5.7028542117758246E-03 5.6720386520079788E-03 5.6413637831740073E-03 5.6108291447523806E-03 5.5804342721671608E-03 + 5.5501787105286899E-03 5.5200620016803053E-03 5.4900836862786292E-03 5.4602433052866666E-03 5.4305404000051958E-03 + 5.4009745069972239E-03 5.3715451750665100E-03 5.3422519468914083E-03 5.3130943651140258E-03 5.2840719727149802E-03 + 5.2551843124301429E-03 5.2264309241511608E-03 5.1978113586095649E-03 5.1693251602796956E-03 5.1409718740042668E-03 + 5.1127510450465347E-03 5.0846622174786473E-03 5.0567049358449696E-03 5.0288787519160230E-03 5.0011832125906172E-03 + 4.9736178652011733E-03 4.9461822575221056E-03 4.9188759352696140E-03 4.8916984477678400E-03 4.8646493481395549E-03 + 4.8377281859553201E-03 4.8109345112757737E-03 4.7842678746203215E-03 4.7577278237210998E-03 4.7313139127421414E-03 + 4.7050256964783904E-03 4.6788627274395042E-03 4.6528245586522224E-03 4.6269107436390563E-03 4.6011208324282854E-03 + 4.5754543841596091E-03 4.5499109556163247E-03 4.5244901024787771E-03 4.4991913809665773E-03 4.4740143478754308E-03 + 4.4489585558352696E-03 4.4240235690486355E-03 4.3992089465969423E-03 4.3745142475771206E-03 4.3499390316610285E-03 + 4.3254828586996386E-03 4.3011452855017335E-03 4.2769258801663200E-03 4.2528242048241547E-03 4.2288398221754196E-03 + 4.2049722956071841E-03 4.1812211877526317E-03 4.1575860613950241E-03 4.1340664871242511E-03 4.1106620308790235E-03 + 4.0873722592675143E-03 4.0641967395340269E-03 4.0411350374219149E-03 4.0181867217936327E-03 3.9953513659887127E-03 + 3.9726285399957553E-03 3.9500178145007682E-03 3.9275187609002192E-03 3.9051309482813494E-03 3.8828539516458233E-03 + 3.8606873473973915E-03 3.8386307097763124E-03 3.8166836137735315E-03 3.7948456350909371E-03 3.7731163464994966E-03 + 3.7514953291793826E-03 3.7299821628511490E-03 3.7085764262401832E-03 3.6872776988134321E-03 3.6660855608325179E-03 + 3.6449995889407945E-03 3.6240193705921811E-03 3.6031444891039084E-03 3.5823745278413567E-03 3.5617090709722638E-03 + 3.5411477032412679E-03 3.5206900061349839E-03 3.5003355727367641E-03 3.4800839904265356E-03 3.4599348474219213E-03 + 3.4398877327321696E-03 3.4199422351413270E-03 3.4000979431868376E-03 3.3803544536229850E-03 3.3607113588214727E-03 + 3.3411682519847263E-03 3.3217247271921753E-03 3.3023803774585919E-03 3.2831347984030716E-03 3.2639875907103278E-03 + 3.2449383518729901E-03 3.2259866802715823E-03 3.2071321751826042E-03 3.1883744340984979E-03 3.1697130597315259E-03 + 3.1511476568997438E-03 3.1326778283952859E-03 3.1143031779331631E-03 3.0960233101042628E-03 3.0778378271070755E-03 + 3.0597463387524908E-03 3.0417484542143011E-03 3.0238437817066495E-03 3.0060319304063845E-03 2.9883125104058950E-03 + 2.9706851287765496E-03 2.9531494024175884E-03 2.9357049450503404E-03 2.9183513704946142E-03 2.9010882934751717E-03 + 2.8839153296527065E-03 2.8668320913342537E-03 2.8498382023297380E-03 2.8329332811744294E-03 2.8161169473575774E-03 + 2.7993888213126115E-03 2.7827485236131574E-03 2.7661956742895430E-03 2.7497299017105788E-03 2.7333508301758862E-03 + 2.7170580849639778E-03 2.7008512923331089E-03 2.6847300779011952E-03 2.6686940694209400E-03 2.6527428999691531E-03 + 2.6368761997178298E-03 2.6210935998434580E-03 2.6053947325046633E-03 2.5897792285454750E-03 2.5742467233614234E-03 + 2.5587968549256896E-03 2.5434292593688370E-03 2.5281435738296019E-03 2.5129394364689153E-03 2.4978164835120914E-03 + 2.4827743579252360E-03 2.4678127027301226E-03 2.4529311601073321E-03 2.4381293732331504E-03 2.4234069863201778E-03 + 2.4087636411278630E-03 2.3941989881367054E-03 2.3797126755443002E-03 2.3653043516421199E-03 2.3509736657164860E-03 + 2.3367202681109649E-03 2.3225438062432179E-03 2.3084439380042635E-03 2.2944203169226163E-03 2.2804725974430334E-03 + 2.2666004350419388E-03 2.2528034855810665E-03 2.2390814041727642E-03 2.2254338541333012E-03 2.2118604950797267E-03 + 2.1983609876567931E-03 2.1849349935499436E-03 2.1715821741821266E-03 2.1583021925743883E-03 2.1450947172466503E-03 + 2.1319594140465727E-03 2.1188959498761131E-03 2.1059039926788568E-03 2.0929832094952801E-03 2.0801332711899321E-03 + 2.0673538515704063E-03 2.0546446227581961E-03 2.0420052579388152E-03 2.0294354313226746E-03 2.0169348156884375E-03 + 2.0045030896152206E-03 1.9921399323015866E-03 1.9798450221608613E-03 1.9676180386663912E-03 1.9554586623509443E-03 + 1.9433665717844639E-03 1.9313414531386835E-03 1.9193829911060751E-03 1.9074908703944566E-03 1.8956647768011243E-03 + 1.8839043971455611E-03 1.8722094158967499E-03 1.8605795267028352E-03 1.8490144197800861E-03 1.8375137861885353E-03 + 1.8260773180144166E-03 1.8147047079639859E-03 1.8033956477538275E-03 1.7921498370545633E-03 1.7809669721652835E-03 + 1.7698467504383014E-03 1.7587888702703942E-03 1.7477930300585582E-03 1.7368589293827836E-03 1.7259862732580985E-03 + 1.7151747642760533E-03 1.7044241060941677E-03 1.6937340034142098E-03 1.6831041603685970E-03 1.6725342842448881E-03 + 1.6620240854506496E-03 1.6515732728894718E-03 1.6411815564848842E-03 1.6308486472345364E-03 1.6205742550298627E-03 + 1.6103580947166047E-03 1.6001998821829613E-03 1.5900993325603549E-03 1.5800561620645088E-03 1.5700700879268741E-03 + 1.5601408258778520E-03 1.5502680981398940E-03 1.5404516261037923E-03 1.5306911311445833E-03 1.5209863357006164E-03 + 1.5113369632408355E-03 1.5017427353067668E-03 1.4922033813940777E-03 1.4827186284097633E-03 1.4732882039360793E-03 + 1.4639118366040330E-03 1.4545892557871701E-03 1.4453201897261707E-03 1.4361043741672290E-03 1.4269415418429376E-03 + 1.4178314264999814E-03 1.4087737629348083E-03 1.3997682860970762E-03 1.3908147317492228E-03 1.3819128409276317E-03 + 1.3730623524688147E-03 1.3642630062539972E-03 1.3555145431676336E-03 1.3468167037710946E-03 1.3381692311857782E-03 + 1.3295718717170467E-03 1.3210243703030678E-03 1.3125264728556932E-03 1.3040779263374638E-03 1.2956784769224030E-03 + 1.2873278748854562E-03 1.2790258718478038E-03 1.2707722187545402E-03 1.2625666675518776E-03 1.2544089711760725E-03 + 1.2462988814116159E-03 1.2382361555418843E-03 1.2302205504853990E-03 1.2222518231505745E-03 1.2143297314302314E-03 + 1.2064540342149605E-03 1.1986244888557397E-03 1.1908408594900107E-03 1.1831029083175487E-03 1.1754103981631216E-03 + 1.1677630928031138E-03 1.1601607568399069E-03 1.1526031536514276E-03 1.1450900535877478E-03 1.1376212243005130E-03 + 1.1301964344433370E-03 1.1228154535904188E-03 1.1154780516915211E-03 1.1081839991187242E-03 1.1009330712576191E-03 + 1.0937250415376687E-03 1.0865596843345577E-03 1.0794367750217367E-03 1.0723560888049263E-03 1.0653174029164325E-03 + 1.0583204977242353E-03 1.0513651523776917E-03 1.0444511469431955E-03 1.0375782624451226E-03 1.0307462793812032E-03 + 1.0239549816236585E-03 1.0172041545339543E-03 1.0104935828881172E-03 1.0038230523510272E-03 9.9719234955969373E-04 + 9.9060126024622911E-04 9.8404957474493770E-04 9.7753708340652182E-04 9.7106357652747288E-04 9.6462884532518825E-04 + 9.5823268193354267E-04 9.5187487730726298E-04 9.4555522806185775E-04 9.3927352949464671E-04 9.3302957736593462E-04 + 9.2682316834151695E-04 9.2065409995473440E-04 9.1452216843525389E-04 9.0842717640218448E-04 9.0236892410211792E-04 + 8.9634721267759974E-04 8.9036184415870691E-04 8.8441262100160756E-04 8.7849934584227846E-04 8.7262182595460958E-04 + 8.6677986689310713E-04 8.6097327509300665E-04 8.5520185786462850E-04 8.4946542255025790E-04 8.4376377800269914E-04 + 8.3809673611750797E-04 8.3246410767219569E-04 8.2686570430925456E-04 8.2130133853248240E-04 8.1577082252395124E-04 + 8.1027397116850372E-04 8.0481060095132190E-04 7.9938052778472568E-04 7.9398356842880083E-04 7.8861954049163187E-04 + 7.8328826094824114E-04 7.7798955053551581E-04 7.7272323029059639E-04 7.6748912116762389E-04 7.6228704495683443E-04 + 7.5711682428162164E-04 7.5197828085864086E-04 7.4687124109906928E-04 7.4179553054820688E-04 7.3675097511513164E-04 + 7.3173740152724829E-04 7.2675463733067654E-04 7.2180250893465864E-04 7.1688084824612051E-04 7.1198948527566763E-04 + 7.0712825079402531E-04 7.0229697637783474E-04 6.9749549407510571E-04 6.9272363590647105E-04 6.8798123813157603E-04 + 6.8326813550170556E-04 6.7858416355806551E-04 6.7392915862975449E-04 6.6930295717844651E-04 6.6470539678066824E-04 + 6.6013631787511921E-04 6.5559555990466194E-04 6.5108296308807293E-04 6.4659836841624648E-04 6.4214161670738030E-04 + 6.3771255091720164E-04 6.3331101561590007E-04 6.2893685484773608E-04 6.2458991341379484E-04 6.2027003687448255E-04 + 6.1597707034775114E-04 6.1171086199415857E-04 6.0747126046875491E-04 6.0325811431967652E-04 5.9907127284137911E-04 + 5.9491058606888107E-04 5.9077590335855450E-04 5.8666707790902897E-04 5.8258396240704665E-04 5.7852640981444117E-04 + 5.7449427382239514E-04 5.7048740884697022E-04 5.6650566842694316E-04 5.6254891062675386E-04 5.5861699211508492E-04 + 5.5470977017409509E-04 5.5082710279818255E-04 5.4696884847663400E-04 5.4313486551034863E-04 5.3932501602736650E-04 + 5.3553916083511608E-04 5.3177716144226243E-04 5.2803888005602381E-04 5.2432417907743046E-04 5.2063292170272362E-04 + 5.1696497376931406E-04 5.1332020023364254E-04 5.0969846673770312E-04 5.0609963960596225E-04 5.0252358509675777E-04 + 4.9897017113080706E-04 4.9543926720414897E-04 4.9193074233000792E-04 4.8844446619194918E-04 4.8498030913855995E-04 + 4.8153814122117088E-04 4.7811783492945757E-04 4.7471926336036609E-04 4.7134229949402753E-04 4.6798681696148754E-04 + 4.6465269004498580E-04 4.6133979252927469E-04 4.5804800130764878E-04 4.5477719303168852E-04 4.5152724455105401E-04 + 4.4829803335518225E-04 4.4508943757017169E-04 4.4190133464774801E-04 4.3873360573544679E-04 4.3558613097775703E-04 + 4.3245879100775630E-04 4.2935146708356558E-04 4.2626404094846211E-04 4.2319639405494257E-04 4.2014841125896586E-04 + 4.1711997627638279E-04 4.1411097343101752E-04 4.1112128765627767E-04 4.0815080412208280E-04 4.0519940853301169E-04 + 4.0226698899143473E-04 3.9935343283018616E-04 3.9645862797608290E-04 3.9358246295230173E-04 3.9072482628930863E-04 + 3.8788560779503027E-04 3.8506469876393220E-04 3.8226199005786469E-04 3.7947737311944981E-04 3.7671073996992235E-04 + 3.7396198244579298E-04 3.7123099430422750E-04 3.6851766998073767E-04 3.6582190377970034E-04 3.6314359057020425E-04 + 3.6048262578715682E-04 3.5783890450752110E-04 3.5521232429906708E-04 3.5260278268162295E-04 3.5001017731528598E-04 + 3.4743440640992815E-04 3.4487536872943096E-04 3.4233296252788751E-04 3.3980708904449971E-04 3.3729764882964216E-04 + 3.3480454281133729E-04 3.3232767245976684E-04 3.2986693970971716E-04 3.2742224613645238E-04 3.2499349631438546E-04 + 3.2258059383233692E-04 3.2018344280751102E-04 3.1780194788034202E-04 3.1543601394457064E-04 3.1308554623248145E-04 + 3.1075045212229408E-04 3.0843063832109758E-04 3.0612601204922852E-04 3.0383648103774342E-04 3.0156195308162647E-04 + 2.9930233693011813E-04 2.9705754271700332E-04 2.9482748018361260E-04 2.9261205957417435E-04 2.9041119162849955E-04 + 2.8822478698362249E-04 2.8605275777464736E-04 2.8389501683854298E-04 2.8175147687200456E-04 2.7962205106208494E-04 + 2.7750665307553095E-04 2.7540519633435892E-04 2.7331759623537073E-04 2.7124376826150796E-04 2.6918362798825616E-04 + 2.6713709146494426E-04 2.6510407521134296E-04 2.6308449537219017E-04 2.6107827047974514E-04 2.5908531861801933E-04 + 2.5710555815907922E-04 2.5513890793843003E-04 2.5318528722816010E-04 2.5124461490308713E-04 2.4931681245118898E-04 + 2.4740180051948448E-04 2.4549950020632058E-04 2.4360983305424732E-04 2.4173272086703963E-04 2.3986808562945629E-04 + 2.3801585123085832E-04 2.3617594097845011E-04 2.3434827861710386E-04 2.3253278832633851E-04 2.3072939438348195E-04 + 2.2893802176836221E-04 2.2715859671930337E-04 2.2539104513114578E-04 2.2363529332274120E-04 2.2189126803697607E-04 + 2.2015889597314290E-04 2.1843810498605281E-04 2.1672882361808575E-04 2.1503098027892686E-04 2.1334450378948978E-04 + 2.1166932338491034E-04 2.1000536812938565E-04 2.0835256864591288E-04 2.0671085573147410E-04 2.0508016023883133E-04 + 2.0346041342230009E-04 2.0185154693544842E-04 2.0025349215978733E-04 1.9866618237461808E-04 1.9708955058441542E-04 + 1.9552353001759068E-04 1.9396805428918831E-04 1.9242305740693389E-04 1.9088847301511230E-04 1.8936423694490589E-04 + 1.8785028436209207E-04 1.8634655079913394E-04 1.8485297217201989E-04 1.8336948463976786E-04 1.8189602444405731E-04 + 1.8043252948477280E-04 1.7897893716861153E-04 1.7753518526967066E-04 1.7610121193118415E-04 1.7467695541012403E-04 + 1.7326235447349614E-04 1.7185734901358955E-04 1.7046187862166049E-04 1.6907588325032423E-04 1.6769930320625930E-04 + 1.6633207879797760E-04 1.6497415121347880E-04 1.6362546229685716E-04 1.6228595376103456E-04 1.6095556767256415E-04 + 1.5963424644057546E-04 1.5832193237380967E-04 1.5701856898956310E-04 1.5572410003671336E-04 1.5443846929216368E-04 + 1.5316162087098881E-04 1.5189349922589370E-04 1.5063404861781181E-04 1.4938321480184361E-04 1.4814094338795188E-04 + 1.4690718015512955E-04 1.4568187120994944E-04 1.4446496298753381E-04 1.4325640165374306E-04 1.4205613511240653E-04 + 1.4086411079479658E-04 1.3968027642136403E-04 1.3850458003199088E-04 1.3733696990153645E-04 1.3617739430703171E-04 + 1.3502580296352595E-04 1.3388214516508673E-04 1.3274637051834525E-04 1.3161842893860730E-04 1.3049827046484312E-04 + 1.2938584549275381E-04 1.2828110541496842E-04 1.2718400136586149E-04 1.2609448477916399E-04 1.2501250739149370E-04 + 1.2393802096558097E-04 1.2287097792857570E-04 1.2181133131545625E-04 1.2075903404228985E-04 1.1971403931945278E-04 + 1.1867630064821204E-04 1.1764577147387975E-04 1.1662240617598278E-04 1.1560615939069745E-04 1.1459698576559518E-04 + 1.1359484023329578E-04 1.1259967800966399E-04 1.1161145418041203E-04 1.1063012499639391E-04 1.0965564666108207E-04 + 1.0868797550253976E-04 1.0772706812338814E-04 1.0677288140064045E-04 1.0582537202297824E-04 1.0488449803769265E-04 + 1.0395021717936181E-04 1.0302248740310041E-04 1.0210126693441738E-04 1.0118651421442021E-04 1.0027818763822288E-04 + 9.9376246834406069E-05 9.8480651078856050E-05 9.7591359908833050E-05 9.6708333121054866E-05 9.5831530638512037E-05 + 9.4960912628439250E-05 9.4096440127704344E-05 9.3238073953790456E-05 9.2385775177452654E-05 9.1539505121013937E-05 + 9.0699225153916229E-05 8.9864897142062929E-05 8.9036483500216568E-05 8.8213946541168230E-05 8.7397248823259784E-05 + 8.6586353148818945E-05 8.5781222299240048E-05 8.4981819770126515E-05 8.4188109322966560E-05 8.3400054721197267E-05 + 8.2617619966509389E-05 8.1840769297402964E-05 8.1069466872226581E-05 8.0303677751538140E-05 7.9543367012457284E-05 + 7.8788499825958202E-05 7.8039041594114969E-05 7.7294957948728678E-05 7.6556214392007528E-05 7.5822777486693292E-05 + 7.5094613595265251E-05 7.4371689254598962E-05 7.3653971225426452E-05 7.2941426466419286E-05 7.2234021866783950E-05 + 7.1531725355922452E-05 7.0834504577300928E-05 7.0142327392937556E-05 6.9455161882653907E-05 6.8772976250769066E-05 + 6.8095738864647136E-05 6.7423418840389476E-05 6.6755985114204153E-05 6.6093406834678826E-05 6.5435653361727445E-05 + 6.4782694115849099E-05 6.4134498883899381E-05 6.3491037942099596E-05 6.2852281481861475E-05 6.2218199900573843E-05 + 6.1588763800915264E-05 6.0963943790962922E-05 6.0343711020659852E-05 5.9728036901001536E-05 5.9116892841891879E-05 + 5.8510250453383429E-05 5.7908081544787207E-05 5.7310357884137898E-05 5.6717051930713093E-05 5.6128136205137909E-05 + 5.5543583300860223E-05 5.4963366005750456E-05 5.4387457301027930E-05 5.3815830087147381E-05 5.3248458082306620E-05 + 5.2685314892313716E-05 5.2126374260016311E-05 5.1571610117697979E-05 5.1020996576339006E-05 5.0474507669061328E-05 + 4.9932118297892948E-05 4.9393803138773436E-05 4.8859537051963374E-05 4.8329295081403137E-05 4.7803052391941828E-05 + 4.7280784255941968E-05 4.6762466581127186E-05 4.6248075134606139E-05 4.5737585862653441E-05 4.5230974890340783E-05 + 4.4728218412704883E-05 4.4229292893909768E-05 4.3734175226976936E-05 4.3242842239882895E-05 4.2755270935226795E-05 + 4.2271438489243866E-05 4.1791322104978263E-05 4.1314899393323893E-05 4.0842148212223256E-05 4.0373046422053655E-05 + 3.9907572052970995E-05 3.9445703304165475E-05 3.8987418365048786E-05 3.8532695950034482E-05 3.8081514863246699E-05 + 3.7633853969629539E-05 3.7189692299700869E-05 3.6749009048343648E-05 3.6311783370446872E-05 3.5877995043613114E-05 + 3.5447623799360942E-05 3.5020649481173229E-05 3.4597052093749576E-05 3.4176811801865110E-05 3.3759908705445763E-05 + 3.3346323607404812E-05 3.2936037148820910E-05 3.2529030126602168E-05 3.2125283494499429E-05 3.1724778323405004E-05 + 3.1327495757512862E-05 3.0933417470507514E-05 3.0542525035198470E-05 3.0154800178024728E-05 2.9770224778768228E-05 + 2.9388780795149466E-05 2.9010450383317726E-05 2.8635216067756361E-05 2.8263060332150290E-05 2.7893965809928346E-05 + 2.7527915284418640E-05 2.7164891583610004E-05 2.6804877840787897E-05 2.6447857416984129E-05 2.6093813685030472E-05 + 2.5742730164204200E-05 2.5394590519948280E-05 2.5049378435397423E-05 2.4707077987615730E-05 2.4367673360749062E-05 + 2.4031148796636739E-05 2.3697488680020458E-05 2.3366677538664855E-05 2.3038699895991920E-05 2.2713540742105689E-05 + 2.2391185071504901E-05 2.2071617975617076E-05 2.1754824686001609E-05 2.1440790574215452E-05 2.1129500989708378E-05 + 2.0820941806653939E-05 2.0515098818083761E-05 2.0211957947311377E-05 1.9911505254759610E-05 1.9613726914782176E-05 + 1.9318609159767981E-05 1.9026138651507841E-05 1.8736301993313977E-05 1.8449085923570118E-05 1.8164477315335054E-05 + 1.7882463127127176E-05 1.7603030468621381E-05 1.7326166757610477E-05 1.7051859399570134E-05 1.6780095932426830E-05 + 1.6510864026459127E-05 1.6244151414196806E-05 1.5979946056494158E-05 1.5718236118733853E-05 1.5459009794111406E-05 + 1.5202255405696354E-05 1.4947961406965123E-05 1.4696116294807780E-05 1.4446708857422410E-05 1.4199728000211400E-05 + 1.3955162690485633E-05 1.3713002023745994E-05 1.3473235223296680E-05 1.3235851541899337E-05 1.3000840573183775E-05 + 1.2768191955603704E-05 1.2537895418525268E-05 1.2309940817799511E-05 1.2084318134779030E-05 1.1861017370533018E-05 + 1.1640028903862023E-05 1.1421343100066381E-05 1.1204950439949809E-05 1.0990841528489818E-05 1.0779007083502077E-05 + 1.0569437881923910E-05 1.0362125034633866E-05 1.0157059640393157E-05 9.9542329212201784E-06 9.7536362222522629E-06 + 9.5552609827806518E-06 9.3590987652799964E-06 9.1651413806963258E-06 8.9733806620257285E-06 8.7838085641804204E-06 + 8.5964171637831507E-06 8.4111986175941034E-06 8.2281452563641859E-06 8.0472495886795539E-06 7.8685041741708536E-06 + 7.6919016932311520E-06 7.5174349468682627E-06 7.3450968060899480E-06 7.1748803544440327E-06 7.0067787965831476E-06 + 6.8407854124087610E-06 6.6768936016577257E-06 6.5150968837331785E-06 6.3553888415628490E-06 6.1977632979110292E-06 + 6.0422141527675618E-06 5.8887354011624889E-06 5.7373211571966985E-06 5.5879656539589619E-06 5.4406631848875268E-06 + 5.2954083001431386E-06 5.1521955952710054E-06 5.0110197764761500E-06 4.8718756685143753E-06 4.7347582103773801E-06 + 4.5996624182472447E-06 4.4665835470109922E-06 4.3355168930994802E-06 4.2064578711800449E-06 4.0794020141595778E-06 + 3.9543449604480745E-06 3.8312824620901245E-06 3.7102104578383303E-06 3.5911249512968709E-06 3.4740220641312847E-06 + 3.3588980361173452E-06 3.2457492075093251E-06 3.1345720572677033E-06 3.0253632120179230E-06 2.9181193820693130E-06 + 2.8128373958807527E-06 2.7095142000599741E-06 2.6081468401488327E-06 2.5087325148657285E-06 2.4112685436671541E-06 + 2.3157523443791496E-06 2.2221814532936109E-06 2.1305535251220797E-06 2.0408663150974894E-06 1.9531177363756853E-06 + 1.8673058071552822E-06 1.7834286549266451E-06 1.7014845260846086E-06 1.6214717860211688E-06 1.5433889050964955E-06 + 1.4672345073628105E-06 1.3930073167167920E-06 1.3207061737136239E-06 1.2503300385051756E-06 1.1818779905884912E-06 + 1.1153492230561063E-06 1.0507430680260568E-06 9.8805896349977339E-07 9.2729646779407697E-07 8.6845525971273560E-07 + 8.1153513860511003E-07 7.5653602627359874E-07 7.0345796452646941E-07 6.5230111405359654E-07 6.0306575697210114E-07 + 5.5575229702980064E-07 5.1036126297865710E-07 4.6689330482026230E-07 4.2534918510898311E-07 3.8572979439765676E-07 + 3.4803614599398123E-07 3.1226937620679805E-07 2.7843075391534082E-07 2.4652165860478284E-07 2.1654358577854651E-07 + 1.8849816439302362E-07 1.6238714771865175E-07 1.3821241363224033E-07 1.1597598302703102E-07 9.5679967979399388E-08 + 7.7326610321206874E-08 6.0918287349453169E-08 4.6457502479425140E-08 3.3946885568115651E-08 2.3389222608041433E-08 + 1.4787363212879796E-08 8.1443101296552468E-09 3.4632003676553971E-09 7.4729909408923743E-10 -1.7026714163125078E-19 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 1.0000000000000000E+20 + 3.3484312211186324E+02 3.3185422449762558E+02 3.2888834091361184E+02 3.2594533724941260E+02 3.2302507950002177E+02 + 3.2012742914663505E+02 3.1725225798690889E+02 3.1439943391754008E+02 3.1156882345368416E+02 3.0876029329501654E+02 + 3.0597371033070681E+02 3.0320893650696405E+02 3.0046584623282524E+02 2.9774430734877160E+02 2.9504418757313806E+02 + 2.9236535487628743E+02 2.8970767683900692E+02 2.8707101839102000E+02 2.8445525474429286E+02 2.8186025492031445E+02 + 2.7928588824977408E+02 2.7673202437500061E+02 2.7419853174894098E+02 2.7168527939420733E+02 2.6919214281255347E+02 + 2.6671899293515941E+02 2.6426570105248226E+02 2.6183213882121834E+02 2.5941817603778242E+02 2.5702368581783270E+02 + 2.5464854446043353E+02 2.5229262511038175E+02 2.4995580131753397E+02 2.4763794704353126E+02 2.4533893383597635E+02 + 2.4305863888409809E+02 2.4079693972447592E+02 2.3855371197446834E+02 2.3632883169539795E+02 2.3412217539730182E+02 + 2.3193361672814885E+02 2.2976303691689529E+02 2.2761031511662779E+02 2.2547532963464658E+02 2.2335795925228453E+02 + 2.2125808323111104E+02 2.1917557761708090E+02 2.1711032762819463E+02 2.1506221436260648E+02 2.1303111899416899E+02 + 2.1101692319667072E+02 2.0901950880524717E+02 2.0703875554196117E+02 2.0507455152598314E+02 2.0312678042155085E+02 + 2.0119532641176886E+02 1.9928007420001029E+02 1.9738090802383590E+02 1.9549771240447814E+02 1.9363037737537394E+02 + 1.9177878970708053E+02 1.8994283670480274E+02 1.8812240620988831E+02 1.8631738506975171E+02 1.8452766245736808E+02 + 1.8275313056022054E+02 1.8099367934451598E+02 1.7924919932255096E+02 1.7751958155489214E+02 1.7580471566981524E+02 + 1.7410449534358489E+02 1.7241881511823198E+02 1.7074756821973520E+02 1.6909064842908651E+02 1.6744795008257242E+02 + 1.6581936572883171E+02 1.6420479339654923E+02 1.6260413014839497E+02 1.6101727251332269E+02 1.5944411758024125E+02 + 1.5788456299803883E+02 1.5633850434358669E+02 1.5480584384881516E+02 1.5328648123098807E+02 1.5178031634623798E+02 + 1.5028724961208201E+02 1.4880718185941996E+02 1.4734001222006231E+02 1.4588564653527615E+02 1.4444398743331291E+02 + 1.4301493810291541E+02 1.4159840229500034E+02 1.4019428368710521E+02 1.3880248603277917E+02 1.3742291762851008E+02 + 1.3605548442978818E+02 1.3470009295110751E+02 1.3335665026481888E+02 1.3202506296297580E+02 1.3070523922078445E+02 + 1.2939708988144818E+02 1.2810052420873419E+02 1.2681545202153340E+02 1.2554178369097791E+02 1.2427942876865950E+02 + 1.2302829965794874E+02 1.2178830981908558E+02 1.2055937179374838E+02 1.1934139867223084E+02 1.1813430409054936E+02 + 1.1693800058634777E+02 1.1575240460555430E+02 1.1457743227442070E+02 1.1341299937289443E+02 1.1225902221972406E+02 + 1.1111541767164988E+02 1.0998210126457300E+02 1.0885899330544503E+02 1.0774601262118647E+02 1.0664307817828319E+02 + 1.0555010947514704E+02 1.0446702650461172E+02 1.0339374789528229E+02 1.0233019754337232E+02 1.0127629702583711E+02 + 1.0023196844081035E+02 9.9197134406696023E+01 9.8171717668907391E+01 9.7155640911255333E+01 9.6148830473788422E+01 + 9.5151211012752952E+01 9.4162707694846290E+01 9.3183246196658388E+01 9.2212752008291034E+01 9.1251151668413058E+01 + 9.0298373974199563E+01 8.9354346595038578E+01 8.8418997698794442E+01 8.7492255950548639E+01 8.6574049570033310E+01 + 8.5664308755286086E+01 8.4762964765862108E+01 8.3869948211648520E+01 8.2985190190064699E+01 8.2108622282295741E+01 + 8.1240175410690384E+01 8.0379783250406774E+01 7.9527379512644814E+01 7.8682897675449809E+01 7.7846271688667855E+01 + 7.7017435975832100E+01 7.6196324125737647E+01 7.5382873114991199E+01 7.4577019090962906E+01 7.3778698320451042E+01 + 7.2987847529436038E+01 7.2204403903534612E+01 7.1428303658739878E+01 7.0659486904222476E+01 6.9897892198596409E+01 + 6.9143458517643509E+01 6.8396125284306962E+01 6.7655832132567866E+01 6.6922518557352205E+01 6.6196126942369148E+01 + 6.5476598456874882E+01 6.4763874705537205E+01 6.4057897726820144E+01 6.3358609534234837E+01 6.2665952812376744E+01 + 6.1979872103953404E+01 6.1300311138634584E+01 6.0627214068266404E+01 5.9960525463877758E+01 5.9300189675222761E+01 + 5.8646152404607136E+01 5.7998360324247543E+01 5.7356759642852616E+01 5.6721296976634221E+01 5.6091919347633706E+01 + 5.5468573392927688E+01 5.4851207668289653E+01 5.4239770943059042E+01 5.3634211821467829E+01 5.3034479302621342E+01 + 5.2440522775326855E+01 5.1852291113870749E+01 5.1269735572710267E+01 5.0692806978589772E+01 5.0121456249802861E+01 + 4.9555634685178433E+01 4.8995293960660938E+01 4.8440385130734725E+01 4.7890862001125257E+01 4.7346677415537116E+01 + 4.6807784524029628E+01 4.6274136843866465E+01 4.5745688123282527E+01 4.5222391936576322E+01 4.4704204106723161E+01 + 4.4191079579233175E+01 4.3682973656513049E+01 4.3179841991626823E+01 4.2681640296187553E+01 4.2188324695586346E+01 + 4.1699852806509213E+01 4.1216181659914142E+01 4.0737268628536931E+01 4.0263071424841208E+01 3.9793547669602084E+01 + 3.9328655895068145E+01 3.8868355472469503E+01 3.8412605438723240E+01 3.7961365159413617E+01 3.7514594326747293E+01 + 3.7072252419021368E+01 3.6634300237157966E+01 3.6200698865345160E+01 3.5771409269097845E+01 3.5346392729761327E+01 + 3.4925610842401625E+01 3.4509024888544090E+01 3.4096597808243608E+01 3.3688292354904291E+01 3.3284071346754445E+01 + 3.2883897905368244E+01 3.2487735453389561E+01 3.2095547020307187E+01 3.1707297563448304E+01 3.1322951459725363E+01 + 3.0942473306011532E+01 3.0565827990255947E+01 3.0192980620728239E+01 2.9823896124472270E+01 2.9458541155591075E+01 + 2.9096881736225257E+01 2.8738884169587159E+01 2.8384515037963553E+01 2.8033741013456265E+01 2.7686529014584792E+01 + 2.7342847133872830E+01 2.7002663041036524E+01 2.6665944675118020E+01 2.6332660242625284E+01 2.6002777930168318E+01 + 2.5676266529825494E+01 2.5353095532286446E+01 2.5033234185976447E+01 2.4716651997188915E+01 2.4403318728460579E+01 + 2.4093204031317988E+01 2.3786278460408251E+01 2.3482512863560107E+01 2.3181878000878925E+01 2.2884344879452488E+01 + 2.2589884751453006E+01 2.2298468683705416E+01 2.2010068889289219E+01 2.1724657531190843E+01 2.1442206816399398E+01 + 2.1162689188095491E+01 2.0886077324068477E+01 2.0612343656538656E+01 2.0341461959373010E+01 2.0073405668363932E+01 + 1.9808148374495545E+01 1.9545663894641990E+01 1.9285926239417769E+01 1.9028909248295005E+01 1.8774588072938993E+01 + 1.8522937409961248E+01 1.8273932173285825E+01 1.8027547492971816E+01 1.7783758596766457E+01 1.7542540849602201E+01 + 1.7303870527439020E+01 1.7067723600782145E+01 1.6834076248067916E+01 1.6602904853829827E+01 1.6374185819681660E+01 + 1.6147895943305151E+01 1.5924012588257744E+01 1.5702512942104608E+01 1.5483374390626176E+01 1.5266574516715956E+01 + 1.5052090852793699E+01 1.4839901542170402E+01 1.4629984999580783E+01 1.4422319574283719E+01 1.4216883804914600E+01 + 1.4013656418040087E+01 1.3812616034692041E+01 1.3613742061959977E+01 1.3417013929274184E+01 1.3222411094603265E+01 + 1.3029913196487053E+01 1.2839500052842213E+01 1.2651151331285389E+01 1.2464847626369984E+01 1.2280569345746986E+01 + 1.2098297004945632E+01 1.1918011291708789E+01 1.1739693056351767E+01 1.1563322996974886E+01 1.1388882798847648E+01 + 1.1216353820215771E+01 1.1045717584863963E+01 1.0876955780810405E+01 1.0710050188553520E+01 1.0544982657733946E+01 + 1.0381735735522504E+01 1.0220291748998742E+01 1.0060633183008839E+01 9.9027426787986172E+00 9.7466029109996342E+00 + 9.5921968092594003E+00 9.4395077516757873E+00 9.2885189884160937E+00 9.1392139199291282E+00 8.9915760955705757E+00 + 8.8455890488748299E+00 8.7012367221950520E+00 8.5585032941221257E+00 8.4173728939147274E+00 8.2778297939791763E+00 + 8.1398584084802810E+00 8.0034430951097537E+00 7.8685687463801930E+00 7.7352203108933288E+00 7.6033827549466171E+00 + 7.4730411810349144E+00 7.3441808266408861E+00 7.2167868397007995E+00 7.0908450040815367E+00 6.9663410086582287E+00 + 6.8432606162891796E+00 6.7215897195004528E+00 6.6013143391500293E+00 6.4824203805235650E+00 6.3648944636161469E+00 + 6.2487229884819948E+00 6.1338924758086009E+00 6.0203895695689900E+00 5.9082009948949521E+00 5.7973135054171125E+00 + 5.6877143826086645E+00 5.5793907498185549E+00 5.4723298486914489E+00 5.3665190378830063E+00 5.2619457143002499E+00 + 5.1585974360691376E+00 5.0564621105007790E+00 4.9555275521213380E+00 4.8557816878098157E+00 4.7572125558304892E+00 + 4.6598081967402250E+00 4.5635569222118546E+00 4.4684472407026377E+00 4.3744676237062494E+00 4.2816066494762559E+00 + 4.1898530021076601E+00 4.0991953383989639E+00 4.0096226760525013E+00 3.9211241004298518E+00 3.8336887072924726E+00 + 3.7473056938170894E+00 3.6619643577450147E+00 3.5776539454101179E+00 3.4943641361067206E+00 3.4120845684101626E+00 + 3.3308049310963028E+00 3.2505150092615684E+00 3.1712046835095680E+00 3.0928637638122156E+00 3.0154825495028987E+00 + 2.9390512092332997E+00 2.8635599949483344E+00 2.7889992500485596E+00 2.7153593857626248E+00 2.6426308191103285E+00 + 2.5708043620863803E+00 2.4998707137149734E+00 2.4298206606176884E+00 2.3606450762198912E+00 2.2923348708222933E+00 + 2.2248810546502433E+00 2.1582749055579606E+00 2.0925076345053704E+00 2.0275705355864972E+00 1.9634549852779990E+00 + 1.9001523710250570E+00 1.8376542581849857E+00 1.7759523710477501E+00 1.7150384063688655E+00 1.6549041397798649E+00 + 1.5955414250454674E+00 1.5369421055045964E+00 1.4790982660937455E+00 1.4220020586157414E+00 1.3656456406781636E+00 + 1.3100212446988020E+00 1.2551211772152455E+00 1.2009377168635933E+00 1.1474634349362689E+00 1.0946908923344170E+00 + 1.0426126837581262E+00 9.9122147482968026E-01 9.4051000145187558E-01 8.9047095765095130E-01 8.4109737007010144E-01 + 7.9238219081152006E-01 7.4431842901032075E-01 6.9689916101977345E-01 6.5011751809864482E-01 6.0396662562514025E-01 + 5.5843990142543265E-01 5.1353068317221584E-01 4.6923237285061015E-01 4.2553843616418369E-01 3.8244237154943922E-01 + 3.3993773797415577E-01 2.9801829659505696E-01 2.5667776077195964E-01 2.1590990479431788E-01 1.7570856333172355E-01 + 1.3606758523737009E-01 9.6980934844854746E-02 5.8442701701815147E-02 2.0446955127393411E-02 -1.7012177836318625E-02 + -5.3940512949931213E-02 -9.0343867151623319E-02 -1.2622789705901194E-01 -1.6159819925227409E-01 -1.9646036721460866E-01 + -2.3081993976220808E-01 -2.6468240153770872E-01 -2.9805325091499113E-01 -3.3093779002057744E-01 -3.6334131563155647E-01 + -3.9526910188707853E-01 -4.2672637115961343E-01 -4.5771829452924118E-01 -4.8825006688901673E-01 -5.1832665878489848E-01 + -5.4795308081543670E-01 -5.7713430475073557E-01 -6.0587525335359094E-01 -6.3418080606947436E-01 -6.6205585312587090E-01 + -6.8950507057797139E-01 -7.1653319079013633E-01 -7.4314489928916971E-01 -7.6934483523855435E-01 -7.9513761020721974E-01 + -8.2052780006791748E-01 -8.4551982999678577E-01 -8.7011815896046873E-01 -8.9432720159339552E-01 -9.1815132864981019E-01 + -9.4159489648419237E-01 -9.6466218731951037E-01 -9.8735738682637308E-01 -1.0096846952362328E+00 -1.0316482708818466E+00 + -1.0532522305643213E+00 -1.0745006875990892E+00 -1.0953976498998876E+00 -1.1159470745575979E+00 -1.1361529170830347E+00 + -1.1560190933198364E+00 -1.1755494798483430E+00 -1.1947479586975316E+00 -1.2136182814360592E+00 -1.2321641872250408E+00 + -1.2503894000811118E+00 -1.2682976065226386E+00 -1.2858924559324763E+00 -1.3031776103480115E+00 -1.3201565817759806E+00 + -1.3368329016789766E+00 -1.3532100751687286E+00 -1.3692915719297205E+00 -1.3850808281389584E+00 -1.4005812918118226E+00 + -1.4157962559121928E+00 -1.4307290524536977E+00 -1.4453829795984867E+00 -1.4597613020344089E+00 -1.4738672619917983E+00 + -1.4877040813292484E+00 -1.5012748711125705E+00 -1.5145827658813051E+00 -1.5276308682196076E+00 -1.5404222490190278E+00 + -1.5529599660430269E+00 -1.5652470300553700E+00 -1.5772863787298073E+00 -1.5890809600003304E+00 -1.6006336915991879E+00 + -1.6119474613307432E+00 -1.6230251515347083E+00 -1.6338695759293249E+00 -1.6444835070234927E+00 -1.6548697164328421E+00 + -1.6650309472351355E+00 -1.6749699142536616E+00 -1.6846893331304569E+00 -1.6941918336397896E+00 -1.7034800310132610E+00 + -1.7125565303174684E+00 -1.7214239096618811E+00 -1.7300847204566061E+00 -1.7385415200374921E+00 -1.7467967664078650E+00 + -1.7548529251441287E+00 -1.7627124440219324E+00 -1.7703777453444420E+00 -1.7778512262200652E+00 -1.7851352936766318E+00 + -1.7922322453102324E+00 -1.7991444043866280E+00 -1.8058740701360636E+00 -1.8124235177678978E+00 -1.8187950047645138E+00 + -1.8249907773341352E+00 -1.8310130014530939E+00 -1.8368638590301827E+00 -1.8425455090918268E+00 -1.8480600879815035E+00 + -1.8534097207586100E+00 -1.8585965030244476E+00 -1.8636224761449702E+00 -1.8684896884051556E+00 -1.8732001664756806E+00 + -1.8777559156505899E+00 -1.8821589352592858E+00 -1.8864111804596750E+00 -1.8905145740744806E+00 -1.8944710382836465E+00 + -1.8982824748836211E+00 -1.9019507654866710E+00 -1.9054777901312674E+00 -1.9088653729697562E+00 -1.9121153241253404E+00 + -1.9152294468049520E+00 -1.9182095249989881E+00 -1.9210573236254680E+00 -1.9237746096053692E+00 -1.9263630848498656E+00 + -1.9288244524221914E+00 -1.9311604032982714E+00 -1.9333726103432023E+00 -1.9354627284325341E+00 -1.9374324172202992E+00 + -1.9392832645849680E+00 -1.9410168719139105E+00 -1.9426348243573810E+00 -1.9441386899729585E+00 -1.9455300230928254E+00 + -1.9468103720567718E+00 -1.9479812280155950E+00 -1.9490440926316608E+00 -1.9500004512601483E+00 -1.9508517731472494E+00 + -1.9515995182703056E+00 -1.9522451283247320E+00 -1.9527900055266749E+00 -1.9532355565341706E+00 -1.9535831726438828E+00 + -1.9538342299596827E+00 -1.9539900989847325E+00 -1.9540521220773777E+00 -1.9540216169757685E+00 -1.9538999007946161E+00 + -1.9536882761943211E+00 -1.9533880314887588E+00 -1.9530004524224205E+00 -1.9525267887579716E+00 -1.9519682780587178E+00 + -1.9513261530758035E+00 -1.9506016329207043E+00 -1.9497959232343438E+00 -1.9489102294475986E+00 -1.9479457150604389E+00 + -1.9469035415493425E+00 -1.9457848621919418E+00 -1.9445908174273430E+00 -1.9433225349699692E+00 -1.9419811442666257E+00 + -1.9405677283928309E+00 -1.9390833766938147E+00 -1.9375291675865278E+00 -1.9359061673972007E+00 -1.9342154320652467E+00 + -1.9324580144037560E+00 -1.9306349272210983E+00 -1.9287471899564472E+00 -1.9267958105255694E+00 -1.9247817854868035E+00 + -1.9227061039945372E+00 -1.9205697439679172E+00 -1.9183736552135262E+00 -1.9161187901178003E+00 -1.9138060902542680E+00 + -1.9114364864772908E+00 -1.9090109047439370E+00 -1.9065302532743564E+00 -1.9039954221038751E+00 -1.9014073005343044E+00 + -1.8987667676819799E+00 -1.8960746925780381E+00 -1.8933319413618852E+00 -1.8905393574131264E+00 -1.8876977740915364E+00 + -1.8848080213459693E+00 -1.8818709195204761E+00 -1.8788872794818712E+00 -1.8758579108239939E+00 -1.8727835965157318E+00 + -1.8696651162828501E+00 -1.8665032442062772E+00 -1.8632987453572434E+00 -1.8600523758840590E+00 -1.8567648919304298E+00 + -1.8534370202407513E+00 -1.8500694897421432E+00 -1.8466630219960414E+00 -1.8432183300697778E+00 -1.8397361193323787E+00 + -1.8362170934337112E+00 -1.8326619287607928E+00 -1.8290713055189984E+00 -1.8254458958721878E+00 -1.8217863640158181E+00 + -1.8180933684082727E+00 -1.8143675606017495E+00 -1.8106095726539078E+00 -1.8068200378561012E+00 -1.8029995819370537E+00 + -1.7991488231447506E+00 -1.7952683756137320E+00 -1.7913588424745837E+00 -1.7874208137975929E+00 -1.7834548787987210E+00 + -1.7794616195676241E+00 -1.7754416111688829E+00 -1.7713954258813494E+00 -1.7673236218112394E+00 -1.7632267493158436E+00 + -1.7591053561805869E+00 -1.7549599835078400E+00 -1.7507911657996142E+00 -1.7465994358088419E+00 -1.7423853097856266E+00 + -1.7381493005407203E+00 -1.7338919169460669E+00 -1.7296136616117306E+00 -1.7253150309102114E+00 -1.7209965203532442E+00 + -1.7166586072341536E+00 -1.7123017688988182E+00 -1.7079264776839163E+00 -1.7035332000278698E+00 -1.6991223967519271E+00 + -1.6946945275938636E+00 -1.6902500342718716E+00 -1.6857893604091387E+00 -1.6813129440396182E+00 -1.6768212176787776E+00 + -1.6723146094722823E+00 -1.6677935433020832E+00 -1.6632584299463982E+00 -1.6587096805006925E+00 -1.6541477008025298E+00 + -1.6495728915282011E+00 -1.6449856500147269E+00 -1.6403863668398704E+00 -1.6357754235781496E+00 -1.6311532007817700E+00 + -1.6265200740998942E+00 -1.6218764143263422E+00 -1.6172225897504879E+00 -1.6125589600750361E+00 -1.6078858792457003E+00 + -1.6032036992006988E+00 -1.5985127672708632E+00 -1.5938134262191528E+00 -1.5891060170015014E+00 -1.5843908706025747E+00 + -1.5796683149427786E+00 -1.5749386751106500E+00 -1.5702022718912547E+00 -1.5654594217796189E+00 -1.5607104399637908E+00 + -1.5559556308129268E+00 -1.5511952976741117E+00 -1.5464297404915932E+00 -1.5416592551524173E+00 -1.5368841335496422E+00 + -1.5321046666248110E+00 -1.5273211340224440E+00 -1.5225338159463138E+00 -1.5177429887678915E+00 -1.5129489250673072E+00 + -1.5081518941946701E+00 -1.5033521627375608E+00 -1.4985499889482834E+00 -1.4937456307102657E+00 -1.4889393423230770E+00 + -1.4841313745274809E+00 -1.4793219754666413E+00 -1.4745113891644626E+00 -1.4696998537046384E+00 -1.4648876060734279E+00 + -1.4600748798995999E+00 -1.4552619054892324E+00 -1.4504489110421070E+00 -1.4456361196670027E+00 -1.4408237504483035E+00 + -1.4360120208160239E+00 -1.4312011450529614E+00 -1.4263913343564949E+00 -1.4215827981705611E+00 -1.4167757402201131E+00 + -1.4119703617153923E+00 -1.4071668617836544E+00 -1.4023654366309206E+00 -1.3975662795461807E+00 -1.3927695823774722E+00 + -1.3879755309040445E+00 -1.3831843094937208E+00 -1.3783961001930549E+00 -1.3736110822644068E+00 -1.3688294322765624E+00 + -1.3640513255799300E+00 -1.3592769312853248E+00 -1.3545064179665514E+00 -1.3497399516759467E+00 -1.3449776958633215E+00 + -1.3402198116823205E+00 -1.3354664583672340E+00 -1.3307177902229730E+00 -1.3259739607814718E+00 -1.3212351211375184E+00 + -1.3165014200034326E+00 -1.3117730040766067E+00 -1.3070500175451878E+00 -1.3023326009855409E+00 -1.2976208938075013E+00 + -1.2929150331464019E+00 -1.2882151539203495E+00 -1.2835213893232205E+00 -1.2788338696200339E+00 -1.2741527224609299E+00 + -1.2694780740920193E+00 -1.2648100486339682E+00 -1.2601487681394923E+00 -1.2554943531076772E+00 -1.2508469209677622E+00 + -1.2462065872357799E+00 -1.2415734658693574E+00 -1.2369476688598910E+00 -1.2323293062322769E+00 -1.2277184866421873E+00 + -1.2231153156184515E+00 -1.2185198973302687E+00 -1.2139323342651911E+00 -1.2093527270890290E+00 -1.2047811746357655E+00 + -1.2002177744819342E+00 -1.1956626211711046E+00 -1.1911158082031201E+00 -1.1865774274100334E+00 -1.1820475688991681E+00 + -1.1775263211407925E+00 -1.1730137711819055E+00 -1.1685100035572735E+00 -1.1640151017732498E+00 -1.1595291477117715E+00 + -1.1550522216515922E+00 -1.1505844024172218E+00 -1.1461257672136180E+00 -1.1416763913668879E+00 -1.1372363489943038E+00 + -1.1328057127349909E+00 -1.1283845537370736E+00 -1.1239729417681621E+00 -1.1195709450296472E+00 -1.1151786301762439E+00 + -1.1107960626240090E+00 -1.1064233063984199E+00 -1.1020604241524872E+00 -1.0977074772377062E+00 -1.0933645255245257E+00 + -1.0890316275796259E+00 -1.0847088407255845E+00 -1.0803962209904134E+00 -1.0760938231250234E+00 -1.0718017006371012E+00 + -1.0675199057232425E+00 -1.0632484893983662E+00 -1.0589875014587093E+00 -1.0547369905276516E+00 -1.0504970040166943E+00 + -1.0462675881088255E+00 -1.0420487879554079E+00 -1.0378406475162356E+00 -1.0336432096199286E+00 -1.0294565159956601E+00 + -1.0252806072381657E+00 -1.0211155227750943E+00 -1.0169613012087126E+00 -1.0128179799536603E+00 -1.0086855953820342E+00 + -1.0045641828222205E+00 -1.0004537765319113E+00 -9.9635440973710010E-01 -9.9226611494051320E-01 -9.8818892349698295E-01 + -9.8412286577190633E-01 -9.8006797119863498E-01 -9.7602426811927612E-01 -9.7199178407895492E-01 -9.6797054591438048E-01 + -9.6396057934677259E-01 -9.5996190921814417E-01 -9.5597455946118992E-01 -9.5199855296870073E-01 -9.4803391207730558E-01 + -9.4408065832842392E-01 -9.4013881225818763E-01 -9.3620839357086638E-01 -9.3228942116336178E-01 -9.2838191283648341E-01 + -9.2448588616075877E-01 -9.2060135777668173E-01 -9.1672834342524112E-01 -9.1286685807366041E-01 -9.0901691595407985E-01 + -9.0517853016225458E-01 -9.0135171390797386E-01 -8.9753647928359737E-01 -8.9373283760304079E-01 -8.8994079947509130E-01 + -8.8616037479764476E-01 -8.8239157239095678E-01 -8.7863440141350446E-01 -8.7488886976272695E-01 -8.7115498467760044E-01 + -8.6743275274713316E-01 -8.6372217981158295E-01 -8.6002327096252762E-01 -8.5633603143488501E-01 -8.5266046532153517E-01 + -8.4899657611271140E-01 -8.4534436670109647E-01 -8.4170383918239500E-01 -8.3807499525687867E-01 -8.3445783652717620E-01 + -8.3085236359507653E-01 -8.2725857650433687E-01 -8.2367647475424211E-01 -8.2010605698870920E-01 -8.1654732182903644E-01 + -8.1300026752523236E-01 -8.0946489147290779E-01 -8.0594119055977720E-01 -8.0242916116895580E-01 -7.9892879877511425E-01 + -7.9544009920223946E-01 -7.9196305761330577E-01 -7.8849766846794977E-01 -7.8504392576100890E-01 -7.8160182302993553E-01 + -7.7817135283612515E-01 -7.7475250847174271E-01 -7.7134528225927301E-01 -7.6794966597610126E-01 -7.6456565097508000E-01 + -7.6119322818493818E-01 -7.5783238752267656E-01 -7.5448311996874717E-01 -7.5114541524683931E-01 -7.4781926268819254E-01 + -7.4450465123510468E-01 -7.4120156932676318E-01 -7.3791000480920821E-01 -7.3462994622800726E-01 -7.3136138104577952E-01 + -7.2810429636581686E-01 -7.2485867894077283E-01 -7.2162451493475199E-01 -7.1840179033603058E-01 -7.1519049146487490E-01 + -7.1199060372898149E-01 -7.0880211220903933E-01 -7.0562500167204500E-01 -7.0245925620718064E-01 -6.9930486014879778E-01 + -6.9616179778106124E-01 -6.9303005264989603E-01 -6.8990960800916146E-01 -6.8680044682489105E-01 -6.8370255130975588E-01 + -6.8061590431826768E-01 -6.7754048828264080E-01 -6.7447628507099655E-01 -6.7142327628569987E-01 -6.6838144327134807E-01 + -6.6535076654288527E-01 -6.6233122763842123E-01 -6.5932280731445336E-01 -6.5632548592466133E-01 -6.5333924359037154E-01 + -6.5036406019961690E-01 -6.4739991473753222E-01 -6.4444678757691043E-01 -6.4150465795814160E-01 -6.3857350488230924E-01 + -6.3565330714337021E-01 -6.3274404321142119E-01 -6.2984569103922361E-01 -6.2695822963605297E-01 -6.2408163698949792E-01 + -6.2121589089462559E-01 -6.1836096896055670E-01 -6.1551684837329712E-01 -6.1268350624132550E-01 -6.0986092029145544E-01 + -6.0704906741924614E-01 -6.0424792434926666E-01 -6.0145746764013930E-01 -5.9867767333118371E-01 -5.9590851780961396E-01 + -5.9314997765214916E-01 -5.9040202878979453E-01 -5.8766464700274057E-01 -5.8493780792648553E-01 -5.8222148658562123E-01 + -5.7951565874879607E-01 -5.7682029997413653E-01 -5.7413538534566411E-01 -5.7146088981594123E-01 -5.6879678821316992E-01 + -5.6614305467024872E-01 -5.6349966443909782E-01 -5.6086659217214840E-01 -5.5824381221846386E-01 -5.5563129881561080E-01 + -5.5302902608940541E-01 -5.5043696739704084E-01 -5.4785509755968054E-01 -5.4528339043953356E-01 -5.4272181975180211E-01 + -5.4017035911787692E-01 -5.3762898197801345E-01 -5.3509766127979475E-01 -5.3257637123440116E-01 -5.3006508510236139E-01 + -5.2756377606388749E-01 -5.2507241721635389E-01 -5.2259098136778814E-01 -5.2011944127379584E-01 -5.1765777049038131E-01 + -5.1520594181606172E-01 -5.1276392798039439E-01 -5.1033170164517028E-01 -5.0790923508089014E-01 -5.0549650091915277E-01 + -5.0309347215255196E-01 -5.0070012119746576E-01 -4.9831642041734381E-01 -4.9594234211901811E-01 -4.9357785812326749E-01 + -4.9122294099514702E-01 -4.8887756325347209E-01 -4.8654169700834721E-01 -4.8421531433107051E-01 -4.8189838724730549E-01 + -4.7959088721270376E-01 -4.7729278678005194E-01 -4.7500405807113766E-01 -4.7272467296394227E-01 -4.7045460330461336E-01 + -4.6819382090921896E-01 -4.6594229694333694E-01 -4.6370000399449773E-01 -4.6146691386522376E-01 -4.5924299826378512E-01 + -4.5702822887886235E-01 -4.5482257731620679E-01 -4.5262601470443253E-01 -4.5043851352905934E-01 -4.4826004540233477E-01 + -4.4609058192472506E-01 -4.4393009468273886E-01 -4.4177855507493141E-01 -4.3963593443946619E-01 -4.3750220501215076E-01 + -4.3537733834550180E-01 -4.3326130598417295E-01 -4.3115407947080919E-01 -4.2905563005622754E-01 -4.2696592931959126E-01 + -4.2488494931487170E-01 -4.2281266158203690E-01 -4.2074903766202509E-01 -4.1869404910199320E-01 -4.1664766706613404E-01 + -4.1460986340197964E-01 -4.1258061003982233E-01 -4.1055987855394077E-01 -4.0854764052886239E-01 -4.0654386756013139E-01 + -4.0454853078196773E-01 -4.0256160233509586E-01 -4.0058305407672967E-01 -3.9861285766143417E-01 -3.9665098475924460E-01 + -3.9469740705843126E-01 -3.9275209570994252E-01 -3.9081502316981248E-01 -3.8888616127438813E-01 -3.8696548179599999E-01 + -3.8505295652905902E-01 -3.8314855726153135E-01 -3.8125225530478885E-01 -3.7936402334985958E-01 -3.7748383329234703E-01 + -3.7561165705871258E-01 -3.7374746660197783E-01 -3.7189123376543265E-01 -3.7004293030338170E-01 -3.6820252891828514E-01 + -3.6637000168657896E-01 -3.6454532072093060E-01 -3.6272845816924715E-01 -3.6091938596729517E-01 -3.5911807632574566E-01 + -3.5732450199713939E-01 -3.5553863527223023E-01 -3.5376044847967658E-01 -3.5198991398698909E-01 -3.5022700386736111E-01 + -3.4847169079053358E-01 -3.4672394760065084E-01 -3.4498374682800353E-01 -3.4325106104545583E-01 -3.4152586286805020E-01 + -3.3980812453851478E-01 -3.3809781919259252E-01 -3.3639491980381997E-01 -3.3469939916518598E-01 -3.3301123011633210E-01 + -3.3133038554672545E-01 -3.2965683790184169E-01 -3.2799056078554967E-01 -3.2633152733159632E-01 -3.2467971062086798E-01 + -3.2303508378275281E-01 -3.2139761999024807E-01 -3.1976729194818654E-01 -3.1814407370620296E-01 -3.1652793859755968E-01 + -3.1491886000940045E-01 -3.1331681138241896E-01 -3.1172176609789315E-01 -3.1013369742834251E-01 -3.0855257958758231E-01 + -3.0697838623112961E-01 -3.0541109107071474E-01 -3.0385066787179088E-01 -3.0229709025771223E-01 -3.0075033205981844E-01 + -2.9921036768484427E-01 -2.9767717112767533E-01 -2.9615071643918395E-01 -2.9463097772722818E-01 -2.9311792887943172E-01 + -2.9161154428033093E-01 -2.9011179855937769E-01 -2.8861866605998421E-01 -2.8713212118900944E-01 -2.8565213841097820E-01 + -2.8417869189712058E-01 -2.8271175658414077E-01 -2.8125130734137960E-01 -2.7979731887864001E-01 -2.7834976596749128E-01 + -2.7690862344259987E-01 -2.7547386577992478E-01 -2.7404546845837485E-01 -2.7262340661172496E-01 -2.7120765532546132E-01 + -2.6979818974885605E-01 -2.6839498509357734E-01 -2.6699801616218205E-01 -2.6560725896577825E-01 -2.6422268892375300E-01 + -2.6284428150351308E-01 -2.6147201224355598E-01 -2.6010585666279334E-01 -2.5874579014377902E-01 -2.5739178898594917E-01 + -2.5604382898565248E-01 -2.5470188600792448E-01 -2.5336593598120366E-01 -2.5203595474262086E-01 -2.5071191827354727E-01 + -2.4939380314423382E-01 -2.4808158555172358E-01 -2.4677524175836335E-01 -2.4547474809788064E-01 -2.4418008073039199E-01 + -2.4289121623235768E-01 -2.4160813145800264E-01 -2.4033080300825335E-01 -2.3905920755413654E-01 -2.3779332183265040E-01 + -2.3653312234943696E-01 -2.3527858625475764E-01 -2.3402969070589036E-01 -2.3278641271388381E-01 -2.3154872935842927E-01 + -2.3031661778883078E-01 -2.2909005486329481E-01 -2.2786901829898193E-01 -2.2665348556541129E-01 -2.2544343408622250E-01 + -2.2423884135618222E-01 -2.2303968493936224E-01 -2.2184594205939323E-01 -2.2065759098250901E-01 -2.1947460950519695E-01 + -2.1829697546815333E-01 -2.1712466678191070E-01 -2.1595766137196820E-01 -2.1479593700270924E-01 -2.1363947231188346E-01 + -2.1248824548788783E-01 -2.1134223478980246E-01 -2.1020141854665439E-01 -2.0906577502825577E-01 -2.0793528260408209E-01 + -2.0680992021346900E-01 -2.0568966646444142E-01 -2.0457450003697863E-01 -2.0346439967871191E-01 -2.0235934401487152E-01 + -2.0125931199779679E-01 -2.0016428288391877E-01 -1.9907423570207711E-01 -1.9798914954910554E-01 -1.9690900359378022E-01 + -1.9583377682378650E-01 -1.9476344876142074E-01 -1.9369799898600240E-01 -1.9263740694462814E-01 -1.9158165215664547E-01 + -1.9053071420788062E-01 -1.8948457245672701E-01 -1.8844320697633121E-01 -1.8740659767951642E-01 -1.8637472443335448E-01 + -1.8534756717179868E-01 -1.8432510590479104E-01 -1.8330732036179292E-01 -1.8229419115319989E-01 -1.8128569853156168E-01 + -1.8028182278026447E-01 -1.7928254425401499E-01 -1.7828784334044290E-01 -1.7729770025598079E-01 -1.7631209602768114E-01 + -1.7533101128751602E-01 -1.7435442673419149E-01 -1.7338232313894206E-01 -1.7241468124045481E-01 -1.7145148182878003E-01 + -1.7049270624785245E-01 -1.6953833554118186E-01 -1.6858835082406101E-01 -1.6764273327759871E-01 -1.6670146399782881E-01 + -1.6576452433471336E-01 -1.6483189594933439E-01 -1.6390356029769149E-01 -1.6297949890430591E-01 -1.6205969336406323E-01 + -1.6114412513204485E-01 -1.6023277609609474E-01 -1.5932562824428481E-01 -1.5842266344047232E-01 -1.5752386361864842E-01 + -1.5662921078023018E-01 -1.5573868674193644E-01 -1.5485227391699036E-01 -1.5396995462166493E-01 -1.5309171112697270E-01 + -1.5221752576863826E-01 -1.5134738095501887E-01 -1.5048125886688435E-01 -1.4961914242416199E-01 -1.4876101427693253E-01 + -1.4790685709770243E-01 -1.4705665362331416E-01 -1.4621038664349165E-01 -1.4536803876382329E-01 -1.4452959333741877E-01 + -1.4369503336926856E-01 -1.4286434193116726E-01 -1.4203750215692038E-01 -1.4121449717547385E-01 -1.4039531012854486E-01 + -1.3957992467999608E-01 -1.3876832422803201E-01 -1.3796049223462623E-01 -1.3715641223159844E-01 -1.3635606768912359E-01 + -1.3555944226698191E-01 -1.3476651994031533E-01 -1.3397728449626781E-01 -1.3319171979027020E-01 -1.3240980973897315E-01 + -1.3163153815816356E-01 -1.3085688920992919E-01 -1.3008584718224350E-01 -1.2931839624835084E-01 -1.2855452064937123E-01 + -1.2779420468601149E-01 -1.2703743251970501E-01 -1.2628418879783579E-01 -1.2553445812242575E-01 -1.2478822505099740E-01 + -1.2404547420168774E-01 -1.2330619025893340E-01 -1.2257035772865559E-01 -1.2183796172672648E-01 -1.2110898717394616E-01 + -1.2038341900224292E-01 -1.1966124220853844E-01 -1.1894244184519277E-01 -1.1822700278202440E-01 -1.1751491057175945E-01 + -1.1680615045804943E-01 -1.1610070774675869E-01 -1.1539856780539609E-01 -1.1469971600859927E-01 -1.1400413771800863E-01 + -1.1331181877884040E-01 -1.1262274480314495E-01 -1.1193690146398402E-01 -1.1125427449596371E-01 -1.1057484959616476E-01 + -1.0989861260133274E-01 -1.0922554965097063E-01 -1.0855564672078037E-01 -1.0788888984652083E-01 -1.0722526512442433E-01 + -1.0656475857445387E-01 -1.0590735649289376E-01 -1.0525304531455926E-01 -1.0460181137378710E-01 -1.0395364106439957E-01 + -1.0330852083966428E-01 -1.0266643704226709E-01 -1.0202737641209329E-01 -1.0139132568087654E-01 -1.0075827153672490E-01 + -1.0012820072645631E-01 -9.9501100055540873E-02 -9.8876956189032972E-02 -9.8255756295795582E-02 -9.7637487405079409E-02 + -9.7022136553914506E-02 -9.6409690837322842E-02 -9.5800137408182606E-02 -9.5193463253455332E-02 -9.4589655956600183E-02 + -9.3988702844727628E-02 -9.3390591299341283E-02 -9.2795308758596359E-02 -9.2202842679450142E-02 -9.1613180485941581E-02 + -9.1026310046308262E-02 -9.0442219024736176E-02 -8.9860895142103520E-02 -8.9282326175263396E-02 -8.8706499881681763E-02 + -8.8133404117484285E-02 -8.7563027026809931E-02 -8.6995356609410851E-02 -8.6430380920904479E-02 -8.5868088072132712E-02 + -8.5308466120902204E-02 -8.4751503340884729E-02 -8.4197188152974778E-02 -8.3645508887874420E-02 -8.3096453931158942E-02 + -8.2550011723424202E-02 -8.2006170622127131E-02 -8.1464919304815503E-02 -8.0926246469643928E-02 -8.0390140773800731E-02 + -7.9856590928354024E-02 -7.9325585698912141E-02 -7.8797113742230501E-02 -7.8271164126555187E-02 -7.7747725827591666E-02 + -7.7226787824545909E-02 -7.6708339149958144E-02 -7.6192368889533582E-02 -7.5678865999076167E-02 -7.5167819924593940E-02 + -7.4659219919908773E-02 -7.4153055281734007E-02 -7.3649315359717624E-02 -7.3147989530026769E-02 -7.2649067123787464E-02 + -7.2152537875277672E-02 -7.1658391342536848E-02 -7.1166617135884513E-02 -7.0677204917578659E-02 -7.0190144343883959E-02 + -6.9705425138930216E-02 -6.9223037295687628E-02 -6.8742970682458424E-02 -6.8265215218897737E-02 -6.7789760876020649E-02 + -6.7316597590363750E-02 -6.6845715466063813E-02 -6.6377104755795974E-02 -6.5910755634225410E-02 -6.5446658326371449E-02 + -6.4984803108456446E-02 -6.4525180196861931E-02 -6.4067780063549018E-02 -6.3612593222201266E-02 -6.3159610149760681E-02 + -6.2708821373298959E-02 -6.2260217469789603E-02 -6.1813788935566216E-02 -6.1369526599739210E-02 -6.0927421236982776E-02 + -6.0487463623087823E-02 -6.0049644583372128E-02 -5.9613954992836789E-02 -5.9180385627000509E-02 -5.8748927661238376E-02 + -5.8319572132179275E-02 -5.7892310111110505E-02 -5.7467132718282049E-02 -5.7044031107233120E-02 -5.6622996380219497E-02 + -5.6204020001408096E-02 -5.5787093285573949E-02 -5.5372207596236046E-02 -5.4959354345811617E-02 -5.4548524951861591E-02 + -5.4139710876317103E-02 -5.3732903829629010E-02 -5.3328095416487968E-02 -5.2925277289845418E-02 -5.2524441150566738E-02 + -5.2125578681445732E-02 -5.1728681693580664E-02 -5.1333742144974770E-02 -5.0940751927361264E-02 -5.0549702980333108E-02 + -5.0160587290948744E-02 -4.9773396807166741E-02 -4.9388123679747833E-02 -4.9004760115623255E-02 -4.8623298290986432E-02 + -4.8243730429601610E-02 -4.7866048802251281E-02 -4.7490245622452569E-02 -4.7116313371760643E-02 -4.6744244507424489E-02 + -4.6374031487561369E-02 -4.6005666817935609E-02 -4.5639143050773809E-02 -4.5274452665836649E-02 -4.4911588467068067E-02 + -4.4550543163134060E-02 -4.4191309492596663E-02 -4.3833880240739476E-02 -4.3478248230792792E-02 -4.3124406235263320E-02 + -4.2772347346822726E-02 -4.2422064535830119E-02 -4.2073550819314159E-02 -4.1726799260214234E-02 -4.1381802937504659E-02 + -4.1038554958419633E-02 -4.0697048655890564E-02 -4.0357277277411771E-02 -4.0019234116561199E-02 -3.9682912513290404E-02 + -3.9348305802860327E-02 -3.9015407419899055E-02 -3.8684210939841229E-02 -3.8354709885817510E-02 -3.8026897826945065E-02 + -3.7700768378596497E-02 -3.7376315134481836E-02 -3.7053531849123987E-02 -3.6732412342673958E-02 -3.6412950413271181E-02 + -3.6095139904475798E-02 -3.5778974706035874E-02 -3.5464448671935461E-02 -3.5151555870088232E-02 -3.4840290368046485E-02 + -3.4530646237801763E-02 -3.4222617597006150E-02 -3.3916198609377828E-02 -3.3611383390982803E-02 -3.3308166316949134E-02 + -3.3006541704991003E-02 -3.2706503900671813E-02 -3.2408047295575143E-02 -3.2111166323809497E-02 -3.1815855374831919E-02 + -3.1522109116706151E-02 -3.1229922122949720E-02 -3.0939289013058376E-02 -3.0650204451993603E-02 -3.0362663129660149E-02 + -3.0076659756208133E-02 -2.9792189242944564E-02 -2.9509246437339008E-02 -2.9227826232840207E-02 -2.8947923568524617E-02 + -2.8669533392846575E-02 -2.8392650731565834E-02 -2.8117270742866875E-02 -2.7843388548803614E-02 -2.7570999317411193E-02 + -2.7300098262839259E-02 -2.7030680595166775E-02 -2.6762741651172352E-02 -2.6496276840071345E-02 -2.6231281559264824E-02 + -2.5967751252711627E-02 -2.5705681410215571E-02 -2.5445067507448453E-02 -2.5185905188319334E-02 -2.4928190116955327E-02 + -2.4671917967812696E-02 -2.4417084461909065E-02 -2.4163685366600740E-02 -2.3911716426633766E-02 -2.3661173589759978E-02 + -2.3412052779700654E-02 -2.3164349949490792E-02 -2.2918061099166425E-02 -2.2673182275841121E-02 -2.2429709496704236E-02 + -2.2187639011527618E-02 -2.1946967007797264E-02 -2.1707689719796731E-02 -2.1469803428679511E-02 -2.1233304449889655E-02 + -2.0998189118151833E-02 -2.0764453942763068E-02 -2.0532095393939871E-02 -2.0301109989053216E-02 -2.0071494293765080E-02 + -1.9843244896215344E-02 -1.9616358447959958E-02 -1.9390831722139016E-02 -1.9166661474658991E-02 -1.8943844510025797E-02 + -1.8722377680733433E-02 -1.8502257853339397E-02 -1.8283481994983333E-02 -1.8066047148033729E-02 -1.7849950358571679E-02 + -1.7635188720834308E-02 -1.7421759378571884E-02 -1.7209659482009265E-02 -1.6998886313021207E-02 -1.6789437190248065E-02 + -1.6581309453163266E-02 -1.6374500490453775E-02 -1.6169007740634418E-02 -1.5964828644207837E-02 -1.5761960797516163E-02 + -1.5560401802473074E-02 -1.5360149296190836E-02 -1.5161200966411673E-02 -1.4963554551453482E-02 -1.4767207787907509E-02 + -1.4572158587982269E-02 -1.4378404843355636E-02 -1.4185944494502559E-02 -1.3994775533085866E-02 -1.3804895994554469E-02 + -1.3616303941425937E-02 -1.3428997580541684E-02 -1.3242975108882395E-02 -1.3058234775428749E-02 -1.2874774881292107E-02 + -1.2692593764889229E-02 -1.2511689822716486E-02 -1.2332061557657148E-02 -1.2153707480326997E-02 -1.1976626154367953E-02 + -1.1800816196687870E-02 -1.1626276256746483E-02 -1.1453005067080777E-02 -1.1281001435576239E-02 -1.1110264193067957E-02 + -1.0940792224592304E-02 -1.0772584469603779E-02 -1.0605639897401075E-02 -1.0439957579345219E-02 -1.0275536637788359E-02 + -1.0112376230997621E-02 -9.9504755727341798E-03 -9.7898339324186123E-03 -9.6304506084414869E-03 -9.4723250146463121E-03 + -9.3154565978326963E-03 -9.1598448515589591E-03 -9.0054893262243620E-03 -8.8523896293496145E-03 -8.7005453981748720E-03 + -8.5499563935692979E-03 -8.4006223972803388E-03 -8.2525432466976547E-03 -8.1057188375082759E-03 -7.9601491211852594E-03 + -7.8158340927520237E-03 -7.6727738569419696E-03 -7.5309685444547711E-03 -7.3904183456807993E-03 -7.2511235109169805E-03 + -7.1130843444745162E-03 -6.9763012118330709E-03 -6.8407745662110381E-03 -6.7065048995480882E-03 -6.5734927651568574E-03 + -6.4417387779950198E-03 -6.3112436072082752E-03 -6.1820079948583916E-03 -6.0540327553789365E-03 -5.9273187524826682E-03 + -5.8018669130804152E-03 -5.6776782276271934E-03 -5.5547537427336870E-03 -5.4330945840824589E-03 -5.3127019407898301E-03 + -5.1935770596443004E-03 -5.0757212526259072E-03 -4.9591358972348011E-03 -4.8438224309071088E-03 -4.7297823710457185E-03 + -4.6170172955175082E-03 -4.5055288463474522E-03 -4.3953187328392967E-03 -4.2863887319423283E-03 -4.1787406860400089E-03 + -4.0723765132689039E-03 -3.9672981951394256E-03 -3.8635077819016883E-03 -3.7610073932663490E-03 -3.6597992190057602E-03 + -3.5598855209908542E-03 -3.4612686285161332E-03 -3.3639509423058957E-03 -3.2679349346204437E-03 -3.1732231496653619E-03 + -3.0798182055559696E-03 -2.9877227950413795E-03 -2.8969396740164896E-03 -2.8074716774907668E-03 -2.7193217145391846E-03 + -2.6324927687015201E-03 -2.5469879033560290E-03 -2.4628102532559936E-03 -2.3799630185649795E-03 -2.2984494841227277E-03 + -2.2182730115208014E-03 -2.1394370395889152E-03 -2.0619450946281971E-03 -1.9858007656984133E-03 -1.9110077157872534E-03 + -1.8375696961361525E-03 -1.7654905375815498E-03 -1.6947741510671120E-03 -1.6254245445518915E-03 -1.5574457747856839E-03 + -1.4908419871572812E-03 -1.4256174168409731E-03 -1.3617763816940150E-03 -1.2993232827254663E-03 -1.2382626291110701E-03 + -1.1785989600311189E-03 -1.1203369237339556E-03 -1.0634812580326339E-03 -1.0080367866066684E-03 -9.5400842076401131E-04 + -9.0140118793710210E-04 -8.5022012924092000E-04 -8.0047041617514855E-04 -7.5215730894083140E-04 -7.0528615703063216E-04 + -6.5986240833289570E-04 -6.1589161180824158E-04 -5.7337934617433719E-04 -5.3233132268808961E-04 -4.9275334489641825E-04 + -4.5465130924078601E-04 -4.1803122336462527E-04 -3.8289917505971571E-04 -3.4926130474767855E-04 -3.1712388540632973E-04 + -2.8649328609160160E-04 -2.5737597258467665E-04 -2.2977853658448654E-04 -2.0370762342668324E-04 -1.7916996052592366E-04 + -1.5617240581148456E-04 -1.3472191728999613E-04 -1.1482555374110526E-04 -9.6490516451555139E-05 -7.9724028435615066E-05 + -6.4533430652102954E-05 -5.0926190526629250E-05 -3.8909879791844062E-05 -2.8492175228713986E-05 -1.9680914484799163E-05 + -1.2483919917062078E-05 -6.9091738703023757E-06 -2.9647791926142165E-06 -6.5894750892967649E-07 1.1936520306921770E-16 diff --git a/src/REPLICA/fix_event_hyper.cpp b/src/REPLICA/fix_event_hyper.cpp new file mode 100644 index 0000000000000000000000000000000000000000..eae1ad021d31596573d43adedf2157009038a58b --- /dev/null +++ b/src/REPLICA/fix_event_hyper.cpp @@ -0,0 +1,95 @@ +/* ---------------------------------------------------------------------- + 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 <cstdlib> +#include <cstring> +#include "fix_event_hyper.h" +#include "atom.h" +#include "update.h" +#include "domain.h" +#include "neighbor.h" +#include "comm.h" +#include "universe.h" +#include "memory.h" +#include "error.h" + +using namespace LAMMPS_NS; +using namespace FixConst; + +/* ---------------------------------------------------------------------- */ + +FixEventHyper::FixEventHyper(LAMMPS *lmp, int narg, char **arg) : + FixEvent(lmp, narg, arg) +{ + if (narg != 3) error->all(FLERR,"Illegal fix event command"); + + restart_global = 1; + + event_number = 0; + event_timestep = update->ntimestep; + clock = 0; +} + +/* ---------------------------------------------------------------------- + save current atom coords as an event (via call to base class) + called when an event occurs in some replica + set event_timestep = when event occurred in a particular replica + update clock = elapsed time since last event, across all replicas +------------------------------------------------------------------------- */ + +void FixEventHyper::store_event_hyper(bigint ntimestep, int delta_clock) +{ + store_event(); + event_timestep = ntimestep; + clock += delta_clock; + event_number++; +} + +/* ---------------------------------------------------------------------- + pack entire state of Fix into one write +------------------------------------------------------------------------- */ + +void FixEventHyper::write_restart(FILE *fp) +{ + int n = 0; + double list[6]; + list[n++] = event_number; + list[n++] = event_timestep; + list[n++] = clock; + list[n++] = replica_number; + list[n++] = correlated_event; + list[n++] = ncoincident; + + 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 FixEventHyper::restart(char *buf) +{ + int n = 0; + double *list = (double *) buf; + + event_number = static_cast<int> (list[n++]); + event_timestep = static_cast<bigint> (list[n++]); + clock = static_cast<bigint> (list[n++]); + replica_number = static_cast<int> (list[n++]); + correlated_event = static_cast<int> (list[n++]); + ncoincident = static_cast<int> (list[n++]); +} diff --git a/src/REPLICA/fix_event_hyper.h b/src/REPLICA/fix_event_hyper.h new file mode 100644 index 0000000000000000000000000000000000000000..4c5d4a93eeab46d0204ddaec02a4d3192eabb6bd --- /dev/null +++ b/src/REPLICA/fix_event_hyper.h @@ -0,0 +1,60 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef FIX_CLASS + +FixStyle(EVENT/HYPER,FixEventHyper) + +#else + +#ifndef LMP_FIX_EVENT_HYPER_H +#define LMP_FIX_EVENT_HYPER_H + +#include "fix_event.h" + +namespace LAMMPS_NS { + +class FixEventHyper : public FixEvent { + public: + int event_number; // event counter + bigint event_timestep; // timestep of last event on any replica + bigint clock; // total elapsed timesteps across all replicas + int replica_number; // replica where last event occured + int correlated_event; // 1 if last event was correlated, 0 otherwise + int ncoincident; // # of simultaneous events on different replicas + + FixEventHyper(class LAMMPS *, int, char **); + ~FixEventHyper() {} + + void write_restart(FILE *); + void restart(char *); + + // methods specific to FixEventHyper, invoked by hyper + + void store_event_hyper(bigint, int); +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +*/ diff --git a/src/REPLICA/fix_hyper.cpp b/src/REPLICA/fix_hyper.cpp new file mode 100644 index 0000000000000000000000000000000000000000..829d4b2474049e4b30386c359a1c944d13cb527e --- /dev/null +++ b/src/REPLICA/fix_hyper.cpp @@ -0,0 +1,35 @@ +/* ---------------------------------------------------------------------- + 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 <cstring> +#include "fix_hyper.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- */ + +FixHyper::FixHyper(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) {} + +/* ---------------------------------------------------------------------- + extract hyper flag setting for all Fixes that perform hyperdynamics +------------------------------------------------------------------------- */ + +void *FixHyper::extract(const char *str, int &dim) +{ + dim = 0; + if (strcmp(str,"hyperflag") == 0) { + return &hyperflag; + } + return NULL; +} + diff --git a/src/REPLICA/fix_hyper.h b/src/REPLICA/fix_hyper.h new file mode 100644 index 0000000000000000000000000000000000000000..7cb6cadf8f5bb2d81573c53b93783cd7a4dc982e --- /dev/null +++ b/src/REPLICA/fix_hyper.h @@ -0,0 +1,43 @@ +/* -*- 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. +------------------------------------------------------------------------- */ + +#ifndef LMP_FIX_HYPER_H +#define LMP_FIX_HYPER_H + +#include "fix.h" + +namespace LAMMPS_NS { + +class FixHyper : public Fix { + public: + FixHyper(class LAMMPS *, int, char **); + virtual ~FixHyper() {} + void *extract(const char *, int &); + + // must be provided by child class + + virtual void init_hyper() = 0; + virtual void build_bond_list(int) = 0; + virtual double query(int) = 0; + + protected: + int hyperflag; +}; + +} + +#endif + +/* ERROR/WARNING messages: + +*/ diff --git a/src/REPLICA/fix_hyper_global.cpp b/src/REPLICA/fix_hyper_global.cpp new file mode 100644 index 0000000000000000000000000000000000000000..d119083a3bdd020af9f6c9493a8e9efd8656a703 --- /dev/null +++ b/src/REPLICA/fix_hyper_global.cpp @@ -0,0 +1,500 @@ +/* ---------------------------------------------------------------------- + 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 <mpi.h> +#include <cmath> +#include <cstdio> +#include <cstring> +#include "fix_hyper_global.h" +#include "atom.h" +#include "update.h" +#include "force.h" +#include "domain.h" +#include "comm.h" +#include "neighbor.h" +#include "neigh_request.h" +#include "neigh_list.h" +#include "modify.h" +#include "math_extra.h" +#include "memory.h" +#include "error.h" + +using namespace LAMMPS_NS; +using namespace FixConst; + +#define DELTA 16384 +#define VECLEN 5 + +// NOTE: count/output # of timesteps on which bias is non-zero +// NOTE: should there be a virial contribution from boosted bond? +// NOTE: allow newton off? see Note in pre_reverse() + +/* ---------------------------------------------------------------------- */ + +FixHyperGlobal::FixHyperGlobal(LAMMPS *lmp, int narg, char **arg) : + FixHyper(lmp, narg, arg), blist(NULL), xold(NULL), tagold(NULL) +{ + if (atom->map_style == 0) + error->all(FLERR,"Fix hyper/global command requires atom map"); + + if (narg != 7) error->all(FLERR,"Illegal fix hyper/global command"); + + hyperflag = 1; + scalar_flag = 1; + vector_flag = 1; + size_vector = 11; + global_freq = 1; + extscalar = 0; + extvector = 0; + + cutbond = force->numeric(FLERR,arg[3]); + qfactor = force->numeric(FLERR,arg[4]); + vmax = force->numeric(FLERR,arg[5]); + tequil = force->numeric(FLERR,arg[6]); + + if (cutbond < 0.0 || qfactor <= 0.0 || vmax < 0.0 || tequil <= 0.0) + error->all(FLERR,"Illegal fix hyper/global command"); + + invqfactorsq = 1.0 / (qfactor*qfactor); + cutbondsq = cutbond*cutbond; + beta = 1.0 / (force->boltz * tequil); + + maxbond = 0; + nblocal = 0; + blist = NULL; + + maxold = 0; + xold = NULL; + tagold = NULL; + + me = comm->me; + firstflag = 1; + bcastflag = 0; + for (int i = 0; i < VECLEN; i++) outvec[i] = 0.0; + + nevent = 0; + nevent_atom = 0; + t_hyper = 0.0; +} + +/* ---------------------------------------------------------------------- */ + +FixHyperGlobal::~FixHyperGlobal() +{ + memory->sfree(blist); + memory->destroy(xold); + memory->destroy(tagold); +} + +/* ---------------------------------------------------------------------- */ + +int FixHyperGlobal::setmask() +{ + int mask = 0; + mask |= PRE_NEIGHBOR; + mask |= PRE_FORCE; + mask |= PRE_REVERSE; + mask |= THERMO_ENERGY; + return mask; +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperGlobal::init_hyper() +{ + maxdriftsq = 0.0; + maxbondlen = 0.0; + nobias = 0; +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperGlobal::init() +{ + if (force->newton_pair == 0) + error->all(FLERR,"Hyper global requires newton pair on"); + + dt = update->dt; + + // need an occasional half neighbor list + + int irequest = neighbor->request(this,instance_me); + neighbor->requests[irequest]->pair = 0; + neighbor->requests[irequest]->fix = 1; + neighbor->requests[irequest]->occasional = 1; +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperGlobal::init_list(int /* id */, NeighList *ptr) +{ + list = ptr; +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperGlobal::setup_pre_neighbor() +{ + pre_neighbor(); +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperGlobal::setup_pre_reverse(int eflag, int vflag) +{ + // no increment in nobias or hyper time when pre-run forces are calculated + + int nobias_hold = nobias; + double t_hyper_hold = t_hyper; + + pre_reverse(eflag,vflag); + + nobias = nobias_hold; + t_hyper = t_hyper_hold; +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperGlobal::pre_neighbor() +{ + int m,iold,jold,ilocal,jlocal; + double distsq; + + // reset local IDs for owned bond atoms, since atoms have migrated + // uses xold and tagold from when bonds were created + // must be done after ghost atoms are setup via comm->borders() + + double **x = atom->x; + + int flag = 0; + + for (m = 0; m < nblocal; m++) { + iold = blist[m].iold; + jold = blist[m].jold; + ilocal = atom->map(tagold[iold]); + jlocal = atom->map(tagold[jold]); + ilocal = domain->closest_image(xold[iold],ilocal); + jlocal = domain->closest_image(xold[iold],jlocal); + blist[m].i = ilocal; + blist[m].j = jlocal; + + if (ilocal < 0 || jlocal < 0) flag++; + else { + distsq = MathExtra::distsq3(x[ilocal],xold[iold]); + maxdriftsq = MAX(distsq,maxdriftsq); + } + } + + if (flag) error->one(FLERR,"Fix hyper/global bond atom not found"); +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperGlobal::pre_reverse(int /* eflag */, int /* vflag */) +{ + int i,j,m,imax,jmax; + double delx,dely,delz; + double r,r0,estrain,rmax,r0max,emax,dt_boost; + double vbias,fbias,fbiasr; + + // compute current strain of each owned bond + // emax = maximum strain of any bond I own + // imax,jmax = local indices of my 2 atoms in that bond + + double **x = atom->x; + emax = 0.0; + + for (m = 0; m < nblocal; m++) { + i = blist[m].i; + j = blist[m].j; + delx = x[i][0] - x[j][0]; + dely = x[i][1] - x[j][1]; + delz = x[i][2] - x[j][2]; + r = sqrt(delx*delx + dely*dely + delz*delz); + maxbondlen = MAX(r,maxbondlen); + r0 = blist[m].r0; + estrain = fabs(r-r0) / r0; + + if (estrain > emax) { + emax = estrain; + rmax = r; + r0max = r0; + imax = i; + jmax = j; + } + } + + // perform Allreduce() on pairme = double/int pair + // finds max strain and what proc owns it + // owner = proc that owns that bond + + pairme.value = emax; + pairme.proc = me; + MPI_Allreduce(&pairme,&pairall,1,MPI_DOUBLE_INT,MPI_MAXLOC,world); + owner = pairall.proc; + + bcastflag = 1; + + // all procs acquire t_hyper from owner proc + // MPI_Bcast call by owner proc is below + + for (int i = 0; i < VECLEN; i++) outvec[i] = 0.0; + + if (owner != me) { + MPI_Bcast(&t_hyper,1,MPI_DOUBLE,owner,world); + return; + } + + // I own the bond with max strain + // compute Vbias and apply force to atoms imax,jmax + // NOTE: logic would need to be different for newton off + + double **f = atom->f; + + vbias = fbias = 0.0; + dt_boost = 1.0; + + if (emax < qfactor) { + vbias = vmax * (1.0 - emax*emax*invqfactorsq); + fbias = 2.0 * vmax * emax / (qfactor*qfactor * r0max); + dt_boost = exp(beta*vbias); + + delx = x[imax][0] - x[jmax][0]; + dely = x[imax][1] - x[jmax][1]; + delz = x[imax][2] - x[jmax][2]; + + fbiasr = fbias / rmax; + f[imax][0] += delx*fbiasr; + f[imax][1] += dely*fbiasr; + f[imax][2] += delz*fbiasr; + + f[jmax][0] -= delx*fbiasr; + f[jmax][1] -= dely*fbiasr; + f[jmax][2] -= delz*fbiasr; + } else nobias++; + + // output quantities + + outvec[0] = vbias; + outvec[1] = dt_boost; + outvec[2] = emax; + outvec[3] = atom->tag[imax]; + outvec[4] = atom->tag[jmax]; + + t_hyper += dt_boost*dt; + MPI_Bcast(&t_hyper,1,MPI_DOUBLE,owner,world); +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperGlobal::build_bond_list(int natom) +{ + int i,j,ii,jj,inum,jnum; + double xtmp,ytmp,ztmp,delx,dely,delz,rsq; + int *ilist,*jlist,*numneigh,**firstneigh; + + if (natom) { + nevent++; + nevent_atom += natom; + } + + // trigger neighbor list build + + neighbor->build_one(list); + + // identify bonds assigned to each owned atom + // do not create a bond between two non-group atoms + + double **x = atom->x; + int *mask = atom->mask; + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + nblocal = 0; + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + jlist = firstneigh[i]; + jnum = numneigh[i]; + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + j &= NEIGHMASK; + + // skip if neither atom I or J are in fix group + + if (!(mask[i] & groupbit) && !(mask[j] & groupbit)) continue; + + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + rsq = delx*delx + dely*dely + delz*delz; + + if (rsq < cutbondsq) { + if (nblocal == maxbond) grow_bond(); + blist[nblocal].i = i; + blist[nblocal].j = j; + blist[nblocal].iold = i; + blist[nblocal].jold = j; + blist[nblocal].r0 = sqrt(rsq); + nblocal++; + } + } + } + + // store IDs and coords for owned+ghost atoms at time of bond creation + // realloc xold and tagold as needed + + if (atom->nmax > maxold) { + memory->destroy(xold); + memory->destroy(tagold); + maxold = atom->nmax; + memory->create(xold,maxold,3,"hyper/global:xold"); + memory->create(tagold,maxold,"hyper/global:tagold"); + } + + tagint *tag = atom->tag; + int nall = atom->nlocal + atom->nghost; + + for (i = 0; i < nall; i++) { + xold[i][0] = x[i][0]; + xold[i][1] = x[i][1]; + xold[i][2] = x[i][2]; + tagold[i] = tag[i]; + } +} + +/* ---------------------------------------------------------------------- + grow bond list by a chunk +------------------------------------------------------------------------- */ + +void FixHyperGlobal::grow_bond() +{ + // NOTE: could add int arg to do initial large alloc: + // maxbond = maxbond/DELTA * DELTA; maxbond += DELTA; + + maxbond += DELTA; + if (maxbond < 0 || maxbond > MAXSMALLINT) + error->one(FLERR,"Fix hyper/local per-processor bond count is too big"); + blist = (OneBond *) + memory->srealloc(blist,maxbond*sizeof(OneBond),"hyper/local:blist"); +} + +/* ---------------------------------------------------------------------- */ + +double FixHyperGlobal::compute_scalar() +{ + if (bcastflag) { + MPI_Bcast(outvec,VECLEN,MPI_DOUBLE,owner,world); + bcastflag = 0; + } + return outvec[0]; +} + +/* ---------------------------------------------------------------------- */ + +double FixHyperGlobal::compute_vector(int i) +{ + if (bcastflag) { + MPI_Bcast(outvec,VECLEN,MPI_DOUBLE,owner,world); + bcastflag = 0; + } + + // 11 vector outputs returned for i = 0-10 + + // i = 0 = boost factor on this step + // i = 1 = max strain of any bond on this step + // i = 2 = ID of atom I in max-strain bond on this step + // i = 3 = ID of atom J in max-strain bond on this step + // i = 4 = ave bonds/atom on this step + + // i = 5 = fraction of steps with no bias during this run + // i = 6 = max drift of any atom during this run + // i = 7 = max bond length during this run + + // i = 8 = cummulative hyper time since fix created + // i = 9 = cummulative # of event timesteps since fix created + // i = 10 = cummulative # of atoms in events since fix created + + if (i == 0) return outvec[1]; + if (i == 1) return outvec[2]; + if (i == 2) return outvec[3]; + if (i == 3) return outvec[4]; + + if (i == 4) { + int allbonds; // NOTE: bigint? + MPI_Allreduce(&nblocal,&allbonds,1,MPI_INT,MPI_SUM,world); + return 2.0*allbonds/atom->natoms; + } + + if (i == 5) { + if (update->ntimestep == update->firststep) return 0.0; + int allnobias; + MPI_Allreduce(&nobias,&allnobias,1,MPI_INT,MPI_SUM,world); + return 1.0*allnobias / (update->ntimestep - update->firststep); + } + + if (i == 6) { + double alldriftsq; + MPI_Allreduce(&maxdriftsq,&alldriftsq,1,MPI_DOUBLE,MPI_MAX,world); + return sqrt(alldriftsq); + } + + if (i == 7) { + double allbondlen; + MPI_Allreduce(&maxbondlen,&allbondlen,1,MPI_DOUBLE,MPI_MAX,world); + return allbondlen; + } + + if (i == 8) return t_hyper; + if (i == 9) return (double) nevent; + if (i == 10) return (double) nevent_atom; + + return 0.0; +} + +/* ---------------------------------------------------------------------- + wrapper on compute_vector() + used by hyper.cpp to call FixHyper +------------------------------------------------------------------------- */ + +double FixHyperGlobal::query(int i) +{ + if (i == 1) return compute_vector(8); // cummulative hyper time + if (i == 2) return compute_vector(9); // nevent + if (i == 3) return compute_vector(10); // nevent_atom + if (i == 4) return compute_vector(4); // ave bonds/atom + if (i == 5) return compute_vector(6); // maxdrift + if (i == 6) return compute_vector(7); // maxbondlen + if (i == 7) return compute_vector(5); // fraction with zero bias + + error->all(FLERR,"Invalid query to fix hyper/global"); + + return 0.0; +} + +/* ---------------------------------------------------------------------- + memory usage of local atom-based arrays +------------------------------------------------------------------------- */ + +double FixHyperGlobal::memory_usage() +{ + double bytes = maxbond * sizeof(OneBond); // blist + return bytes; +} diff --git a/src/REPLICA/fix_hyper_global.h b/src/REPLICA/fix_hyper_global.h new file mode 100644 index 0000000000000000000000000000000000000000..d8b1cef425032dcaa4ec8aef38dbaa1925d4ef2e --- /dev/null +++ b/src/REPLICA/fix_hyper_global.h @@ -0,0 +1,110 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef FIX_CLASS + +FixStyle(hyper/global,FixHyperGlobal) + +#else + +#ifndef LMP_FIX_HYPER_GLOBAL_H +#define LMP_FIX_HYPER_GLOBAL_H + +#include "fix_hyper.h" + +namespace LAMMPS_NS { + +class FixHyperGlobal : public FixHyper { + public: + FixHyperGlobal(class LAMMPS *, int, char **); + ~FixHyperGlobal(); + int setmask(); + void init(); + void init_list(int, class NeighList *); + void setup_pre_neighbor(); + void setup_pre_reverse(int, int); + void pre_neighbor(); + void pre_reverse(int, int); + double compute_scalar(); + double compute_vector(int); + double query(int); + + double memory_usage(); + + // extra methods visible to callers + + void init_hyper(); + void build_bond_list(int); + + private: + int me; + double cutbond,qfactor,vmax,tequil; + + int firstflag,bcastflag,owner,nevent,nevent_atom; + double cutbondsq,beta,dt,t_hyper,invqfactorsq; + double outvec[5]; // same as VECLEN in *.cpp + double maxbondlen; // max length of any bond + double maxdriftsq; // max distance any atom drifts from original pos + int nobias; // # of steps when bias = 0, b/c bond too long + + class NeighList *list; + + // list of my owned bonds + // persists on a proc from one event until the next + + int maxbond; // allocated size of blist + + struct OneBond { // single IJ bond, atom I is owner + int i,j; // current local indices of 2 bond atoms + int iold,jold; // local indices when bonds were formed + double r0; // relaxed bond length + }; + + struct OneBond *blist; // list of owned bonds + int nblocal; // # of owned bonds + + // coords and IDs of owned+ghost atoms when bonds were formed + // persists on a proc from one event until the next + + int maxold; // allocated size of old atoms + + double **xold; // coords of atoms when bonds were formed + tagint *tagold; // IDs of atoms when bonds were formed + + // MPI data struct for finding bond with max strain via Allreduce + + struct Two { + double value; + int proc; + }; + Two pairme,pairall; + + // internal methods + + void grow_bond(); +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +*/ diff --git a/src/REPLICA/fix_hyper_local.cpp b/src/REPLICA/fix_hyper_local.cpp new file mode 100644 index 0000000000000000000000000000000000000000..dac88a8efa7e1fd3b92247b36e80c0c0497a888b --- /dev/null +++ b/src/REPLICA/fix_hyper_local.cpp @@ -0,0 +1,1439 @@ +/* ---------------------------------------------------------------------- + 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 Gene<ral Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#include <mpi.h> +#include <cmath> +#include <cstdio> +#include <cstring> +#include "fix_hyper_local.h" +#include "atom.h" +#include "update.h" +#include "force.h" +#include "pair.h" +#include "domain.h" +#include "comm.h" +#include "neighbor.h" +#include "neigh_request.h" +#include "neigh_list.h" +#include "modify.h" +#include "math_extra.h" +#include "memory.h" +#include "error.h" + +using namespace LAMMPS_NS; +using namespace FixConst; + +#define DELTABOOST 16 +#define BOOSTINIT 1.0 +#define COEFFMAX 1.2 +#define BIG 1.0e20 + +enum{STRAIN,STRAINREGION,BIASFLAG}; +enum{IGNORE,WARN,ERROR}; + +/* ---------------------------------------------------------------------- */ + +FixHyperLocal::FixHyperLocal(LAMMPS *lmp, int narg, char **arg) : + FixHyper(lmp, narg, arg), old2now(NULL), xold(NULL), tagold(NULL), + bonds(NULL), numbond(NULL), maxstrain(NULL), maxstrain_region(NULL), + maxstrain_bondindex(NULL), biasflag(NULL), boost(NULL), + histo(NULL), allhisto(NULL) +{ + // error checks + // solution for tagint != int is to worry about storing + // local index vs global ID in same variable + // maybe need to declare them all tagint, not int + + if (atom->map_style == 0) + error->all(FLERR,"Fix hyper/local command requires atom map"); + + if (sizeof(tagint) != sizeof(int)) + error->all(FLERR,"Fix hyper/local requires tagint = int"); + + // parse args + + if (narg < 10) error->all(FLERR,"Illegal fix hyper/local command"); + + hyperflag = 2; + scalar_flag = 1; + vector_flag = 1; + size_vector = 23; + + global_freq = 1; + extscalar = 0; + extvector = 0; + + cutbond = force->numeric(FLERR,arg[3]); + qfactor = force->numeric(FLERR,arg[4]); + vmax = force->numeric(FLERR,arg[5]); + tequil = force->numeric(FLERR,arg[6]); + dcut = force->numeric(FLERR,arg[7]); + alpha_user = force->numeric(FLERR,arg[8]); + boosttarget = force->numeric(FLERR,arg[9]); + + if (cutbond < 0.0 || qfactor < 0.0 || vmax < 0.0 || + tequil <= 0.0 || dcut <= 0.0 || alpha_user <= 0.0 || boosttarget < 1.0) + error->all(FLERR,"Illegal fix hyper/local command"); + + invqfactorsq = 1.0 / (qfactor*qfactor); + cutbondsq = cutbond*cutbond; + dcutsq = dcut*dcut; + beta = 1.0 / (force->boltz * tequil); + + // optional args + + histoflag = 0; + lostbond = IGNORE; + checkbias = 0; + checkcoeff = 0; + + int iarg = 10; + while (iarg < narg) { + /* NOTE: do not enable this yet, need to think about it differently + if (strcmp(arg[iarg],"histo") == 0) { + if (iarg+5 > narg) error->all(FLERR,"Illegal fix hyper/local command"); + histoflag = 1; + histo_every = force->inumeric(FLERR,arg[iarg+1]); + histo_count = force->inumeric(FLERR,arg[iarg+2]); + histo_delta = force->numeric(FLERR,arg[iarg+3]); + histo_print = force->inumeric(FLERR,arg[iarg+4]); + if (histo_every <= 0 || histo_count % 2 || + histo_delta <= 0.0 || histo_print <= 0) + error->all(FLERR,"Illegal fix hyper/local command"); + iarg += 5; + */ + + if (strcmp(arg[iarg],"lostbond") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix hyper/local command"); + if (strcmp(arg[iarg+1],"error") == 0) lostbond = ERROR; + else if (strcmp(arg[iarg+1],"warn") == 0) lostbond = WARN; + else if (strcmp(arg[iarg+1],"ignore") == 0) lostbond = IGNORE; + else error->all(FLERR,"Illegal fix hyper/local command"); + iarg += 2; + + } else if (strcmp(arg[iarg],"check/bias") == 0) { + if (iarg+3 > narg) error->all(FLERR,"Illegal fix hyper/local command"); + checkbias = 1; + checkbias_every = force->inumeric(FLERR,arg[iarg+1]); + if (strcmp(arg[iarg+2],"error") == 0) checkbias_flag = ERROR; + else if (strcmp(arg[iarg+2],"warn") == 0) checkbias_flag = WARN; + else if (strcmp(arg[iarg+2],"ignore") == 0) checkbias_flag = IGNORE; + else error->all(FLERR,"Illegal fix hyper/local command"); + iarg += 3; + + } else if (strcmp(arg[iarg],"check/coeff") == 0) { + if (iarg+3 > narg) error->all(FLERR,"Illegal fix hyper/local command"); + checkcoeff = 1; + checkcoeff_every = force->inumeric(FLERR,arg[iarg+1]); + if (strcmp(arg[iarg+2],"error") == 0) checkcoeff_flag = ERROR; + else if (strcmp(arg[iarg+2],"warn") == 0) checkcoeff_flag = WARN; + else if (strcmp(arg[iarg+2],"ignore") == 0) checkcoeff_flag = IGNORE; + else error->all(FLERR,"Illegal fix hyper/local command"); + iarg += 3; + + } else error->all(FLERR,"Illegal fix hyper/local command"); + } + + // per-atom data structs + + maxbond = 0; + bonds = NULL; + numbond = NULL; + maxstrain = NULL; + maxstrain_region = NULL; + maxstrain_bondindex = NULL; + biasflag = NULL; + + maxold = old_nall = 0; + old2now = NULL; + xold = NULL; // NOTE: don't really need except to monitor drift + tagold = NULL; + + nboost = maxboost = 0; + boost = NULL; + + // maxbondperatom = max # of bonds any atom is part of + // will be reset in bond_build() + // set comm size needed by this fix + + maxbondperatom = 1; + comm_forward = 1; + comm_reverse = 1; + + // perform initial allocation of atom-based arrays + // register with Atom class + + grow_arrays(atom->nmax); + atom->add_callback(0); + + me = comm->me; + firstflag = 1; + + allbonds = 0; + allboost = 0.0; + + starttime = update->ntimestep; + nostrainyet = 1; + nnewbond = 0; + nevent = 0; + nevent_atom = 0; + mybias = 0.0; + + histo = allhisto = NULL; + if (histoflag) { + invhisto_delta = 1.0 / histo_delta; + histo_lo = 1.0 - (histo_count/2 * histo_delta); + histo = new bigint[histo_count+2]; + allhisto = new bigint[histo_count+2]; + } +} + +/* ---------------------------------------------------------------------- */ + +FixHyperLocal::~FixHyperLocal() +{ + memory->destroy(bonds); + memory->destroy(numbond); + + memory->destroy(maxstrain); + memory->destroy(maxstrain_region); + memory->destroy(maxstrain_bondindex); + memory->destroy(biasflag); + + memory->destroy(old2now); + memory->destroy(xold); + memory->destroy(tagold); + memory->destroy(boost); + delete [] histo; + delete [] allhisto; +} + +/* ---------------------------------------------------------------------- */ + +int FixHyperLocal::setmask() +{ + int mask = 0; + mask |= PRE_NEIGHBOR; + mask |= PRE_REVERSE; + mask |= MIN_PRE_NEIGHBOR; + mask |= THERMO_ENERGY; + return mask; +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperLocal::init_hyper() +{ + ghost_toofar = 0; + lostbond_partner = 0; + lostbond_coeff = 0.0; + checkbias_count = 0; + checkcoeff_count = 0; + maxdriftsq = 0.0; + maxbondlen = 0.0; + maxboostcoeff = 0.0; + minboostcoeff = BIG; + sumboostcoeff = 0.0; + nboost_running = 0; + nobias_running = 0; + rmaxever = 0.0; + rmaxeverbig = 0.0; + + nbondbuild = 0; + time_bondbuild = 0.0; + + if (histoflag) histo_steps = 0; +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperLocal::init() +{ + // for newton off, bond force bias will not be applied correctly + // bonds that straddle 2 procs + // warn if molecular system, since near-neighbors may not appear in neigh list + // user should not be including bonded atoms as hyper "bonds" + + if (force->newton_pair == 0) + error->all(FLERR,"Hyper local requires newton pair on"); + + if (atom->molecular && me == 0) + error->warning(FLERR,"Hyper local for molecular systems " + "requires care in defining hyperdynamics bonds"); + + // cutghost = communication cutoff as calculated by Neighbor and Comm + // error if cutghost is smaller than Dcut + // warn if no drift distance added to cutghost + + if (firstflag) { + double cutghost; + if (force->pair) + cutghost = MAX(force->pair->cutforce+neighbor->skin,comm->cutghostuser); + else + cutghost = comm->cutghostuser; + + if (cutghost < dcut) + error->all(FLERR,"Fix hyper/local bond cutoff exceeds ghost atom range - " + "use comm_modify cutoff command"); + if (cutghost < dcut+cutbond/2.0 && me == 0) + error->warning(FLERR,"Fix hyper/local ghost atom range " + "may not allow for atom drift between events"); + } + + + alpha = update->dt / alpha_user; + + // need an occasional full neighbor list with cutoff = Dcut + // do not need to include neigh skin in cutoff, + // b/c this list will be built every time bond_build() is called + // NOTE: what if pair style list cutoff > Dcut + // or what if neigh skin is huge? + + int irequest = neighbor->request(this,instance_me); + neighbor->requests[irequest]->pair = 0; + neighbor->requests[irequest]->fix = 1; + neighbor->requests[irequest]->half = 0; + neighbor->requests[irequest]->full = 1; + neighbor->requests[irequest]->cut = 1; + neighbor->requests[irequest]->cutoff = dcut; + neighbor->requests[irequest]->occasional = 1; + + // extra timing output + + //timefirst = timesecond = timethird = timefourth = timefifth = + // timesixth = timeseventh = timetotal = 0.0; +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperLocal::init_list(int /* id */, NeighList *ptr) +{ + list = ptr; +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperLocal::setup_pre_neighbor() +{ + // called for dynamics and minimization NOTE: check if min is needed? + + pre_neighbor(); +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperLocal::setup_pre_reverse(int eflag, int vflag) +{ + // only called for dynamics, not minimization + // setupflag prevents boostostat update of boost coeffs in setup + // also prevents increments of nboost_running, nbias_running, sumboostcoeff + + setupflag = 1; + pre_reverse(eflag,vflag); + setupflag = 0; +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperLocal::pre_neighbor() +{ + int i,m,n,ilocal,jlocal; + + // convert global ID bond partners back to local indices + // need to use closest_image() so can calculate bond lengths + // error flag should not happen for a well-behaved system + // b/c are only looking up bond partners inside or near my sub-domain + + double **x = atom->x; + int nlocal = atom->nlocal; + + int missing = 0; + double missing_coeff = 0.0; + + for (i = 0; i < nlocal; i++) { + n = numbond[i]; + for (m = 0; m < n; m++) { + jlocal = atom->map(bonds[i][m].jtag); + if (jlocal >= 0) bonds[i][m].j = domain->closest_image(i,jlocal); + else { + bonds[i][m].j = -1; + missing++; + missing_coeff += bonds[i][m].boostcoeff; + if (lostbond != IGNORE) { + char str[128]; + sprintf(str,"Fix hyper/local bond info missing for bond " + TAGINT_FORMAT "," TAGINT_FORMAT + " with coeff %g at step " BIGINT_FORMAT, + atom->tag[i],bonds[i][m].jtag,bonds[i][m].boostcoeff, + update->ntimestep); + if (lostbond == ERROR) error->one(FLERR,str); + if (lostbond == WARN) error->warning(FLERR,str); + } + } + } + } + + lostbond_partner += missing; + lostbond_coeff += missing_coeff; + + // set old2now to point to current local atom indices + // only necessary for tagold entries > 0 + // because if tagold = 0, atom is not active in Dcut neighbor list + // must be done after atoms migrate and ghost atoms setup via comm->borders() + // does not matter if there are multiple ghost copies of a global ID + // since only need the ghost atom strain, not its coordinates + // NOTE: maybe need not use closest image, b/c old2now only used to access + // maxstrain values, which will be same for any copy of ghost atom ?? + // also need it to compute maxdriftsq correctly when a proc spans a PBC + + double distsq; + + for (i = 0; i < old_nall; i++) { + if (tagold[i] == 0) continue; + ilocal = atom->map(tagold[i]); + ilocal = domain->closest_image(xold[i],ilocal); + old2now[i] = ilocal; + + if (ilocal >= 0) { + distsq = MathExtra::distsq3(x[ilocal],xold[i]); + maxdriftsq = MAX(distsq,maxdriftsq); + } else ghost_toofar++; + } +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperLocal::pre_reverse(int /* eflag */, int /* vflag */) +{ + int i,j,m,ii,jj,inum,jnum,iold,jold,nbond,bondindex; + tagint itag,jtag; + double xtmp,ytmp,ztmp,delx,dely,delz; + double r,r0,estrain,emax,vbias,fbias,fbiasr,boostcoeff; + int *ilist,*jlist,*numneigh,**firstneigh; + + //double time1,time2,time3,time4,time5,time6,time7,time8; + //time1 = MPI_Wtime(); + + // compute current maxstrain and maxstrain_bond for each owned atom + // use per-atom full bond list + // this is double-calculating for IJ and JI bonds + // could compute once, but would have to find/store index of JI bond + // order two I,J atoms consistently for IJ and JI calcs + // to insure no round-off issue when comparing maxstrain values of I,J + + double **x = atom->x; + tagint *tag = atom->tag; + int nlocal = atom->nlocal; + + int mybonds = 0; + nostrainyet = 0; + + for (i = 0; i < nlocal; i++) { + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + itag = tag[i]; + emax = 0.0; + bondindex = -1; + jtag = 0; + + nbond = numbond[i]; + mybonds += nbond; + for (m = 0; m < nbond; m++) { + j = bonds[i][m].j; + if (j < 0) continue; + jtag = bonds[i][m].jtag; + r0 = bonds[i][m].r0; + if (itag < jtag) { + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + } else { + delx = x[j][0] - xtmp; + dely = x[j][1] - ytmp; + delz = x[j][2] - ztmp;; + } + r = sqrt(delx*delx + dely*dely + delz*delz); + maxbondlen = MAX(r,maxbondlen); + estrain = fabs(r-r0) / r0; + if (estrain > emax) { + emax = estrain; + bondindex = m; + } + } + maxstrain[i] = emax; + maxstrain_bondindex[i] = bondindex; + } + + //time2 = MPI_Wtime(); + + // forward comm to acquire maxstrain of all ghost atoms + + commflag = STRAIN; + comm->forward_comm_fix(this); + + //time3 = MPI_Wtime(); + + // use original Dcut neighbor list to check maxstrain of all neighbor atoms + // set maxstrain_region of I atoms = maxstrain of I and all J neighs + // neighbor list has old indices for IJ b/c reneighboring may have occurred + // use old2now[] to convert to current indices + // if neighbor is not currently known (too far away), + // then assume it was part of an event and its strain = qfactor + // this double loop sets maxstrain_region of mostly owned atoms + // but possibly some ghost atoms as well + + int nall = nlocal + atom->nghost; + for (i = 0; i < nall; i++) maxstrain_region[i] = 0.0; + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + // find largest distance from subbox that a ghost atom is with strain < qfactor + + double rmax = rmaxever; + double rmaxbig = rmaxeverbig; + double *sublo = domain->sublo; + double *subhi = domain->subhi; + + for (ii = 0; ii < inum; ii++) { + iold = ilist[ii]; + jlist = firstneigh[iold]; + jnum = numneigh[iold]; + + // I and J may be ghost atoms + // will always know I b/c atoms do not drift that far + // but may no longer know J if hops outside cutghost + // in that case, assume it performed an event, its strain = qfactor + + i = old2now[iold]; + emax = maxstrain[i]; + + for (jj = 0; jj < jnum; jj++) { + jold = jlist[jj]; + j = old2now[jold]; + if (j >= 0) emax = MAX(emax,maxstrain[j]); + else { + emax = MAX(emax,qfactor); + continue; + } + + if (j >= nlocal) { + if (x[j][0] < sublo[0]) rmaxbig = MAX(rmaxbig,sublo[0]-x[j][0]); + if (x[j][1] < sublo[1]) rmaxbig = MAX(rmaxbig,sublo[1]-x[j][1]); + if (x[j][2] < sublo[2]) rmaxbig = MAX(rmaxbig,sublo[2]-x[j][2]); + if (x[j][0] > subhi[0]) rmaxbig = MAX(rmaxbig,x[j][0]-subhi[0]); + if (x[j][1] > subhi[1]) rmaxbig = MAX(rmaxbig,x[j][1]-subhi[1]); + if (x[j][2] > subhi[2]) rmaxbig = MAX(rmaxbig,x[j][2]-subhi[2]); + if (maxstrain[j] < qfactor) { + if (x[j][0] < sublo[0]) rmax = MAX(rmax,sublo[0]-x[j][0]); + if (x[j][1] < sublo[1]) rmax = MAX(rmax,sublo[1]-x[j][1]); + if (x[j][2] < sublo[2]) rmax = MAX(rmax,sublo[2]-x[j][2]); + if (x[j][0] > subhi[0]) rmax = MAX(rmax,x[j][0]-subhi[0]); + if (x[j][1] > subhi[1]) rmax = MAX(rmax,x[j][1]-subhi[1]); + if (x[j][2] > subhi[2]) rmax = MAX(rmax,x[j][2]-subhi[2]); + } + } + } + + maxstrain_region[i] = emax; + } + + double rmax2[2],rmax2all[2]; + rmax2[0] = rmax; + rmax2[1] = rmaxbig; + MPI_Allreduce(&rmax2,&rmax2all,2,MPI_DOUBLE,MPI_MAX,world); + rmaxever = rmax2all[0]; + rmaxeverbig = rmax2all[1]; + + MPI_Allreduce(&mybonds,&allbonds,1,MPI_INT,MPI_SUM,world); + + //time4 = MPI_Wtime(); + + // reverse comm to acquire maxstrain_region from ghost atoms + // needed b/c neighbor list referred to old owned atoms, + // so above loop may set maxstrain_region of ghost atoms + // forward comm to acquire maxstrain_region of all ghost atoms + + commflag = STRAINREGION; + comm->reverse_comm_fix(this); + comm->forward_comm_fix(this); + + //time5 = MPI_Wtime(); + + // identify biased bonds and add to boost list + // for each max-strain bond IJ of atom I: + // bias this bond only if all these conditions hold: + // itag < jtag, so bond is only biased once + // maxstrain[i] = maxstrain_region[i] + // maxstrain[j] = maxstrain_region[j] + // NOTE: also need to check that maxstrain[i] = maxstrain[j] ?? + // don't think so, b/c maxstrain_region[i] includes maxstrain[i] + + nboost = 0; + + for (i = 0; i < nlocal; i++) { + if (numbond[i] == 0) continue; + itag = tag[i]; + j = bonds[i][maxstrain_bondindex[i]].j; + jtag = tag[j]; + if (itag > jtag) continue; + + if (maxstrain[i] != maxstrain_region[i]) continue; + if (maxstrain[j] != maxstrain_region[j]) continue; + + if (nboost == maxboost) { + maxboost += DELTABOOST; + memory->grow(boost,maxboost,"hyper/local:boost"); + } + boost[nboost++] = i; + } + + //time6 = MPI_Wtime(); + + // apply boost force to bonds with locally max strain + + double **f = atom->f; + + int nobias = 0; + mybias = 0.0; + + for (int iboost = 0; iboost < nboost; iboost++) { + i = boost[iboost]; + emax = maxstrain[i]; + if (emax >= qfactor) { + nobias++; + continue; + } + + m = maxstrain_bondindex[i]; + j = bonds[i][m].j; + r0 = bonds[i][m].r0; + boostcoeff = bonds[i][m].boostcoeff; + + vbias = boostcoeff * vmax * (1.0 - emax*emax*invqfactorsq); + fbias = boostcoeff * 2.0 * vmax * emax / (qfactor*qfactor * r0); + + delx = x[i][0] - x[j][0]; + dely = x[i][1] - x[j][1]; + delz = x[i][2] - x[j][2]; + r = sqrt(delx*delx + dely*dely + delz*delz); + fbiasr = fbias / r; + + f[i][0] += delx*fbiasr; + f[i][1] += dely*fbiasr; + f[i][2] += delz*fbiasr; + + f[j][0] -= delx*fbiasr; + f[j][1] -= dely*fbiasr; + f[j][2] -= delz*fbiasr; + + mybias += vbias; + } + + //time7 = MPI_Wtime(); + + // no boostostat update of boost coeffs when pre_reverse called from setup() + // nboost_running, nobias_running, sumboostcoeff only incremented on run steps + // NOTE: maybe should also not bias any bonds on firststep of this fix + + if (setupflag) return; + nboost_running += nboost; + nobias_running += nobias; + + // apply boostostat to boost coefficients of all bonds of all owned atoms + // use per-atom full bond list + // this is double-calculating for IJ and JI bonds + // should be identical for both, b/c emax is the same + // could compute once, but would have to find/store index of JI bond + // delta in boost coeff is function of maxboost_region vs target boost + // maxboost_region is function of two maxstrain_regions for I,J + // NOTE: if J is lost to I but not vice versa, then biascoeff IJ != JI + + double myboost = 0.0; + double emaxi,emaxj,maxboost_region; + + for (i = 0; i < nlocal; i++) { + emaxi = maxstrain_region[i]; + nbond = numbond[i]; + for (m = 0; m < nbond; m++) { + j = bonds[i][m].j; + if (j < 0) continue; + emaxj = maxstrain_region[j]; + emax = MAX(emaxi,emaxj); + if (emax < qfactor) vbias = vmax * (1.0 - emax*emax*invqfactorsq); + else vbias = 0.0; + boostcoeff = bonds[i][m].boostcoeff; + maxboost_region = exp(beta * boostcoeff*vbias); + boostcoeff -= alpha * (maxboost_region-boosttarget) / boosttarget; + // COMMENT OUT for now - need better way to bound boostcoeff + //boostcoeff = MIN(boostcoeff,COEFFMAX); + myboost += boostcoeff; + maxboostcoeff = MAX(maxboostcoeff,boostcoeff); + minboostcoeff = MIN(minboostcoeff,boostcoeff); + bonds[i][m].boostcoeff = boostcoeff; + } + } + + // running stats + + MPI_Allreduce(&myboost,&allboost,1,MPI_DOUBLE,MPI_SUM,world); + if (allbonds) sumboostcoeff += allboost/allbonds; + + // histogram the bond coeffs and output as requested + // do not double count each bond + + if (histoflag && update->ntimestep % histo_every == 0) { + if (histo_steps == 0) + for (i = 0; i < histo_count+2; i++) histo[i] = 0; + histo_steps++; + + int ihisto; + for (i = 0; i < nlocal; i++) { + nbond = numbond[i]; + for (m = 0; m < nbond; m++) { + if (tag[i] > bonds[i][m].jtag) continue; + boostcoeff = bonds[i][m].boostcoeff; + if (boostcoeff < histo_lo) ihisto = -1; + else ihisto = static_cast<int> ((boostcoeff-histo_lo) * invhisto_delta); + if (ihisto >= histo_count) ihisto = histo_count; + histo[ihisto+1]++; + } + } + + if (update->ntimestep % histo_print == 0) { + MPI_Allreduce(histo,allhisto,histo_count+2,MPI_LMP_BIGINT,MPI_SUM,world); + + bigint total; + for (i = 0; i < histo_count+2; i++) total += allhisto[i]; + + if (me == 0) { + if (screen) { + fprintf(screen,"Histogram of bias coeffs:\n"); + for (i = 0; i < histo_count+2; i++) + fprintf(screen," %g",1.0*allhisto[i]/total); + fprintf(screen,"\n"); + } + if (logfile) { + fprintf(logfile,"Histogram of bias coeffs:\n"); + for (i = 0; i < histo_count+2; i++) + fprintf(logfile," %g",1.0*allhisto[i]/total); + fprintf(logfile,"\n"); + } + } + } + } + + // check for any biased bonds that are too close to each other + // keep a running count for output + + if (checkbias && update->ntimestep % checkbias_every == 0) { + + // mark each atom in a biased bond with ID of partner + // nboost loop will mark some ghost atoms + + for (i = 0; i < nall; i++) biasflag[i] = 0; + + for (int iboost = 0; iboost < nboost; iboost++) { + i = boost[iboost]; + m = maxstrain_bondindex[i]; + j = bonds[i][m].j; + biasflag[i] = tag[j]; + biasflag[j] = tag[i]; + } + + // reverse comm to acquire biasflag from ghost atoms + // needed b/c above loop may set biasflag of ghost atoms + // forward comm to acquire biasflag of all ghost atoms + + commflag = BIASFLAG; + comm->reverse_comm_fix(this); + comm->forward_comm_fix(this); + + // I and J may be ghost atoms + // only continue if I is a biased atom + // if J is unknonw (drifted ghost) just ignore + // if J is biased and is not bonded to I, then flag as too close + + for (ii = 0; ii < inum; ii++) { + iold = ilist[ii]; + i = old2now[iold]; + if (biasflag[i] == 0) continue; + + jlist = firstneigh[iold]; + jnum = numneigh[iold]; + + for (jj = 0; jj < jnum; jj++) { + jold = jlist[jj]; + j = old2now[jold]; + if (j < 0) continue; + if (biasflag[j] && biasflag[j] != tag[i]) checkbias_count++; + } + } + } + + // check for any bond bias coeffcients that do not match + // cannot check unless both atoms IJ are owned by this proc + // keep a running count for output + + if (checkcoeff && update->ntimestep % checkcoeff_every == 0) { + int jb,jbonds; + + for (i = 0; i < nlocal; i++) { + nbond = numbond[i]; + for (m = 0; m < nbond; m++) { + if (tag[i] > bonds[i][m].jtag) continue; + j = bonds[i][m].j; + if (j < 0) continue; + if (j >= nlocal) continue; + itag = tag[i]; + jbonds = numbond[j]; + for (jb = 0; jb < jbonds; jb++) + if (bonds[j][jb].jtag == itag) break; + if (jb == jbonds) + error->one(FLERR,"Fix hyper/local could not find duplicate bond"); + if (bonds[i][m].boostcoeff != bonds[j][jb].boostcoeff) + checkcoeff_count++; + } + } + } +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperLocal::min_pre_neighbor() +{ + pre_neighbor(); +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperLocal::build_bond_list(int natom) +{ + int i,j,ii,jj,m,n,inum,jnum,nbond; + tagint itag,jtag; + double xtmp,ytmp,ztmp,delx,dely,delz,rsq,oldcoeff; + int *ilist,*jlist,*numneigh,**firstneigh; + + double time1,time2; + time1 = MPI_Wtime(); + + if (natom) { + nevent++; + nevent_atom += natom; + } + + // trigger Dcut neighbor list build + // NOTE: turn off special bonds in this Dcut neigh list? + + neighbor->build_one(list); + + // make copy of old bonds to preserve boostcoeffs for bonds that persist + // allocate new numbond + + OneBond **old_bonds = bonds; + int *old_numbond = numbond; + + int nmax = atom->nmax; + memory->create(numbond,nmax,"hyper/local:numbond"); + + // old_nall = value of nall at time bonds are built + // reallocate new xold and tagold if necessary + // initialize xold to current coords + // initialize tagold to zero, so atoms not in neighbor list will remain zero + + old_nall = atom->nlocal + atom->nghost; + + if (old_nall > maxold) { + memory->destroy(xold); + memory->destroy(tagold); + memory->destroy(old2now); + maxold = atom->nmax; + memory->create(xold,maxold,3,"hyper/local:xold"); + memory->create(tagold,maxold,"hyper/local:tagold"); + memory->create(old2now,maxold,"hyper/local:old2now"); + } + + double **x = atom->x; + + memcpy(&xold[0][0],&x[0][0],3*old_nall*sizeof(double)); + for (i = 0; i < old_nall; i++) tagold[i] = 0; + + // create and populate new bonds data struct + // while loop allows maxbondperatom to increase once if necessary + // don't know new maxbondperatom value until end of loop + // in practice maxbondperatom will hardly ever increase + // since there is a physical max value + + tagint *tag = atom->tag; + int *mask = atom->mask; + int nlocal = atom->nlocal; + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + + while (1) { + bonds = (OneBond **) memory->create(bonds,nmax,maxbondperatom, + "hyper/local:bonds"); + if (bonds) memset(bonds[0],0,nmax*sizeof(OneBond)); + for (i = 0; i < nlocal; i++) numbond[i] = 0; + + // identify bonds assigned to each owned atom + // do not create a bond between two non-group atoms + // set tagold = global ID for all I,J atoms used in neighbor list + // tagold remains 0 for unused atoms, skipped in pre_neighbor + + int nbondmax = 0; + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + xtmp = x[i][0]; + ytmp = x[i][1]; + ztmp = x[i][2]; + itag = tag[i]; + tagold[i] = tag[i]; + jlist = firstneigh[i]; + jnum = numneigh[i]; + nbond = 0; + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + j &= NEIGHMASK; + jtag = tag[j]; + tagold[j] = jtag; + + // skip if neither atom I or J are in fix group + // order IJ to insure IJ and JI bonds are stored consistently + + if (!(mask[i] & groupbit) && !(mask[j] & groupbit)) continue; + + if (itag < jtag) { + delx = xtmp - x[j][0]; + dely = ytmp - x[j][1]; + delz = ztmp - x[j][2]; + } else { + delx = x[j][0] - xtmp; + dely = x[j][1] - ytmp; + delz = x[j][2] - ztmp; + } + + rsq = delx*delx + dely*dely + delz*delz; + + // NOTE: could create two bonds for IJ both owned from one calc? + // have to skip one of 2 bonds in that case + + if (rsq < cutbondsq) { + if (nbond >= maxbondperatom) { + nbond++; + continue; + } + + bonds[i][nbond].r0 = sqrt(rsq); + bonds[i][nbond].jtag = tag[j]; + bonds[i][nbond].j = j; + + if (firstflag) oldcoeff = 0.0; + else { + oldcoeff = 0.0; + jtag = tag[j]; + n = old_numbond[i]; + for (m = 0; m < n; m++) { + if (old_bonds[i][m].jtag == jtag) { + oldcoeff = old_bonds[i][m].boostcoeff; + break; + } + } + } + + if (oldcoeff > 0.0) bonds[i][nbond].boostcoeff = oldcoeff; + else { + bonds[i][nbond].boostcoeff = BOOSTINIT; + nnewbond++; + } + nbond++; + } + } + numbond[i] = nbond; + nbondmax = MAX(nbondmax,nbond); + } + + // maxbondperatom must increase uniformly on all procs + // since bonds are comunicated when atoms migrate + + int allnbondmax; + MPI_Allreduce(&nbondmax,&allnbondmax,1,MPI_INT,MPI_MAX,world); + if (allnbondmax <= maxbondperatom) break; + + maxbondperatom = allnbondmax; + memory->destroy(bonds); + } + + // deallocate old_bonds and old_numbond + + memory->destroy(old_bonds); + memory->destroy(old_numbond); + + time2 = MPI_Wtime(); + if (firstflag) nnewbond = 0; + else { + time_bondbuild += time2-time1; + nbondbuild++; + } + firstflag = 0; +} + +/* ---------------------------------------------------------------------- */ + +int FixHyperLocal::pack_forward_comm(int n, int *list, double *buf, + int /* pbc_flag */, int * /* pbc */) +{ + int i,j,m; + + m = 0; + + // STRAIN + // pack maxstrain vector + + if (commflag == STRAIN) { + for (i = 0; i < n; i++) { + j = list[i]; + buf[m++] = maxstrain[j]; + } + + // STRAINREGION + // pack maxstrain_region vector + + } else if (commflag == STRAINREGION) { + for (i = 0; i < n; i++) { + j = list[i]; + buf[m++] = maxstrain_region[j]; + } + + // BIASFLAG + // pack biasflag vector + + } else if (commflag == BIASFLAG) { + for (i = 0; i < n; i++) { + j = list[i]; + buf[m++] = ubuf(biasflag[j]).d; + } + } + + return m; +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperLocal::unpack_forward_comm(int n, int first, double *buf) +{ + int i,m,last; + + m = 0; + last = first + n; + + // STRAIN + // unpack maxstrain vector + + if (commflag == STRAIN) { + for (i = first; i < last; i++) { + maxstrain[i] = buf[m++]; + } + + // STRAINREGION + // unpack maxstrain_region vector + + } else if (commflag == STRAINREGION) { + for (i = first; i < last; i++) { + maxstrain_region[i] = buf[m++]; + } + + // BIASFLAG + // unpack biasflag vector + + } else if (commflag == BIASFLAG) { + for (i = first; i < last; i++) { + biasflag[i] = (tagint) ubuf(buf[m++]).i; + } + } +} + +/* ---------------------------------------------------------------------- */ + +int FixHyperLocal::pack_reverse_comm(int n, int first, double *buf) +{ + int i,m,last; + + m = 0; + last = first + n; + + // STRAINREGION + // pack maxstrain_region vector + + if (commflag == STRAINREGION) { + for (i = first; i < last; i++) { + buf[m++] = maxstrain_region[i]; + } + + // BIASFLAG + // pack biasflag vector + + } else if (commflag == BIASFLAG) { + for (i = first; i < last; i++) { + buf[m++] = ubuf(biasflag[i]).d; + } + } + + return m; +} + +/* ---------------------------------------------------------------------- */ + +void FixHyperLocal::unpack_reverse_comm(int n, int *list, double *buf) +{ + int i,j,m; + + m = 0; + + // STRAINREGION + // unpack maxstrain_region vector + + if (commflag == STRAINREGION) { + for (i = 0; i < n; i++) { + j = list[i]; + maxstrain_region[j] += buf[m++]; + } + + // BIASFLAG + // unpack biasflag vector + + } else if (commflag == BIASFLAG) { + for (i = 0; i < n; i++) { + j = list[i]; + biasflag[j] = (tagint) ubuf(buf[m++]).i; + } + } +} + +/* ---------------------------------------------------------------------- + allocate atom-based arrays +------------------------------------------------------------------------- */ + +void FixHyperLocal::grow_arrays(int nmax) +{ + // NOTE: not all of these need to be Nmax in length, could allocate elsewhere + + memory->grow(maxstrain,nmax,"hyper/local:maxstrain"); + memory->grow(maxstrain_bondindex,nmax,"hyper/local:maxstrain_bondindex"); + memory->grow(maxstrain_region,nmax,"hyper/local:maxstrain_region"); + if (checkbias) memory->grow(biasflag,nmax,"hyper/local:biasflag"); + + memory->grow(numbond,nmax,"hyper/local:numbond"); + memory->grow(bonds,nmax,maxbondperatom,"hyper/local:bonds"); + + // zero so valgrind does not complain about memcpy() in copy() + // also so loops in pre_neighbor() are OK before + // bonds are setup for the first time + + if (bonds) { + memset(bonds[maxbond],0,(nmax-maxbond)*maxbondperatom*sizeof(OneBond)); + memset(&numbond[maxbond],0,(nmax-maxbond)*sizeof(int)); + maxbond = nmax; + } +} + +/* ---------------------------------------------------------------------- + copy values within local atom-based arrays +------------------------------------------------------------------------- */ + +void FixHyperLocal::copy_arrays(int i, int j, int /* delflag */) +{ + // avoid valgrind copy-to-self warning + + if (i != j) memcpy(bonds[j],bonds[i],numbond[i]*sizeof(OneBond)); + numbond[j] = numbond[i]; +} + +/* ---------------------------------------------------------------------- + pack values in local atom-based array for exchange with another proc +------------------------------------------------------------------------- */ + +int FixHyperLocal::pack_exchange(int i, double *buf) +{ + int m = 1; + int n = numbond[i]; + buf[m++] = ubuf(n).d; + for (int j = 0; j < n; j++) { + buf[m++] = bonds[i][j].r0; + buf[m++] = bonds[i][j].boostcoeff; + buf[m++] = ubuf(bonds[i][j].jtag).d; + buf[m++] = ubuf(bonds[i][j].j).d; + } + + buf[0] = m; + return m; +} + +/* ---------------------------------------------------------------------- + unpack values in local atom-based array from exchange with another proc +------------------------------------------------------------------------- */ + +int FixHyperLocal::unpack_exchange(int nlocal, double *buf) +{ + int m = 1; + int n = numbond[nlocal] = (int) ubuf(buf[m++]).i; + for (int j = 0; j < n; j++) { + bonds[nlocal][j].r0 = buf[m++]; + bonds[nlocal][j].boostcoeff = buf[m++]; + bonds[nlocal][j].jtag = (tagint) ubuf(buf[m++]).i; + bonds[nlocal][j].j = (int) ubuf(buf[m++]).i; + } + + return m; +} + +/* ---------------------------------------------------------------------- */ + +double FixHyperLocal::compute_scalar() +{ + double allbias; + MPI_Allreduce(&mybias,&allbias,1,MPI_DOUBLE,MPI_SUM,world); + return allbias; +} + +/* ---------------------------------------------------------------------- */ + +double FixHyperLocal::compute_vector(int i) +{ + // 23 vector outputs returned for i = 0-22 + + // i = 0 = # of boosted bonds on this step + // i = 1 = max strain of any bond on this step + // i = 2 = average bias potential for all bonds on this step + // i = 3 = ave bonds/atom on this step + // i = 4 = ave neighbor bonds/bond on this step + + // i = 5 = fraction of steps and bonds with no bias during this run + // i = 6 = max drift distance of any atom during this run + // i = 7 = max bond length during this run + // i = 8 = average # of boosted bonds/step during this run + // i = 9 = average bias potential for all bonds during this run + // i = 10 = max bias potential for any bond during this run + // i = 11 = min bias potential for any bond during this run + // i = 12 = max dist from my box of any ghost atom with + // maxstain < qfactor during this run + // i = 13 = max dist from my box of any ghost atom with + // any maxstrain during this run + // i = 14 = count of ghost atoms that could not be found + // by any proc at any reneighbor step during this run + // i = 15 = count of lost bond partners during this run + // i = 16 = average bias coeff for lost bond partners during this run + // i = 17 = count of bias overlaps found during this run + // i = 18 = count of non-matching bias coefficients found during this run + + // i = 19 = cummulative hyper time + // i = 20 = cummulative # of event timesteps since fix created + // i = 21 = cummulative # of atoms in events since fix created + // i = 22 = cummulative # of new bonds formed since fix created + + if (i == 0) { + int nboostall; + MPI_Allreduce(&nboost,&nboostall,1,MPI_INT,MPI_SUM,world); + return (double) nboostall; + } + + if (i == 1) { + if (nostrainyet) return 0.0; + int nlocal = atom->nlocal; + double emax = 0.0; + for (int j = 0; j < nlocal; j++) + emax = MAX(emax,maxstrain[j]); + double eall; + MPI_Allreduce(&emax,&eall,1,MPI_DOUBLE,MPI_MAX,world); + return eall; + } + + if (i == 2) { + if (allboost && allbonds) return allboost/allbonds * vmax; + return 1.0; + } + + if (i == 3) return 1.0*allbonds/atom->natoms; + + if (i == 4) { + int nlocal = atom->nlocal; + int nbonds = 0; // BIGINT? + for (int j = 0; j < nlocal; j++) + nbonds += numbond[j]; + int allbonds; + MPI_Allreduce(&nbonds,&allbonds,1,MPI_INT,MPI_SUM,world); + int allneigh; // BIGINT? + MPI_Allreduce(&list->ipage->ndatum,&allneigh,1,MPI_INT,MPI_SUM,world); + double neighsperatom = allneigh/atom->natoms; + double bondsperatom = 0.5*allbonds/atom->natoms; + return neighsperatom * bondsperatom; + } + + if (i == 5) { + int allboost_running,allnobias_running; + MPI_Allreduce(&nboost_running,&allboost_running,1,MPI_INT,MPI_SUM,world); + MPI_Allreduce(&nobias_running,&allnobias_running,1,MPI_INT,MPI_SUM,world); + if (allboost_running) return 1.0*allnobias_running / allboost_running; + return 0.0; + } + + if (i == 6) { + double alldriftsq; + MPI_Allreduce(&maxdriftsq,&alldriftsq,1,MPI_DOUBLE,MPI_MAX,world); + return (double) sqrt(alldriftsq); + } + + if (i == 7) { + double allbondlen; + MPI_Allreduce(&maxbondlen,&allbondlen,1,MPI_DOUBLE,MPI_MAX,world); + return allbondlen; + } + + if (i == 8) { + if (update->ntimestep == update->firststep) return 0.0; + int allboost_running; + MPI_Allreduce(&nboost_running,&allboost_running,1,MPI_INT,MPI_SUM,world); + return 1.0*allboost_running / (update->ntimestep - update->firststep); + } + + if (i == 9) { + if (update->ntimestep == update->firststep) return 0.0; + return sumboostcoeff * vmax / (update->ntimestep - update->firststep); + } + + if (i == 10) { + double allboostcoeff; + MPI_Allreduce(&maxboostcoeff,&allboostcoeff,1,MPI_DOUBLE,MPI_MAX,world); + return allboostcoeff * vmax; + } + + if (i == 11) { + double allboostcoeff; + MPI_Allreduce(&minboostcoeff,&allboostcoeff,1,MPI_DOUBLE,MPI_MAX,world); + return allboostcoeff * vmax; + } + + if (i == 12) return rmaxever; + if (i == 13) return rmaxeverbig; + + if (i == 14) { + int allghost_toofar; + MPI_Allreduce(&ghost_toofar,&allghost_toofar,1,MPI_INT,MPI_SUM,world); + return 1.0*allghost_toofar; + } + + if (i == 15) { + int alllost; + MPI_Allreduce(&lostbond_partner,&alllost,1,MPI_INT,MPI_SUM,world); + return 1.0*alllost; + } + + if (i == 16) { + int alllost; + MPI_Allreduce(&lostbond_partner,&alllost,1,MPI_INT,MPI_SUM,world); + double allcoeff; + MPI_Allreduce(&lostbond_coeff,&allcoeff,1,MPI_DOUBLE,MPI_SUM,world); + if (alllost == 0) return 0; + return allcoeff/alllost; + } + + if (i == 17) { + int allclose; + MPI_Allreduce(&checkbias_count,&allclose,1,MPI_INT,MPI_SUM,world); + return 1.0*allclose; + } + + if (i == 18) { + int allcoeff; + MPI_Allreduce(&checkcoeff_count,&allcoeff,1,MPI_INT,MPI_SUM,world); + return 1.0*allcoeff; + } + + if (i == 19) { + return boosttarget * update->dt * (update->ntimestep - starttime); + } + + if (i == 20) return (double) nevent; + if (i == 21) return (double) nevent_atom; + + if (i == 22) { + int allnew; + MPI_Allreduce(&nnewbond,&allnew,1,MPI_INT,MPI_SUM,world); + return (double) 0.5*allnew; + } + + return 0.0; +} + +/* ---------------------------------------------------------------------- + wrapper on compute_vector() + used by hyper.cpp to call FixHyper +------------------------------------------------------------------------- */ + +double FixHyperLocal::query(int i) +{ + if (i == 1) return compute_vector(19); // cummulative hyper time + if (i == 2) return compute_vector(20); // nevent + if (i == 3) return compute_vector(21); // nevent_atom + if (i == 4) return compute_vector(3); // ave bonds/atom + if (i == 5) return compute_vector(6); // maxdrift + if (i == 6) return compute_vector(7); // maxbondlen + if (i == 7) return compute_vector(5); // fraction with zero bias + + // unique to local hyper + + if (i == 8) return compute_vector(22); // number of new bonds + if (i == 9) return 1.0*maxbondperatom; // max bonds/atom + if (i == 10) return compute_vector(8); // ave # of boosted bonds/step + if (i == 11) return compute_vector(9); // ave boost coeff over all bonds + if (i == 12) return compute_vector(10); // max boost cooef for any bond + if (i == 13) return compute_vector(11); // max boost cooef for any bond + if (i == 14) return compute_vector(4); // neighbor bonds/bond + if (i == 15) return compute_vector(2); // ave boost cooef now + if (i == 16) return time_bondbuild; // CPU time for bond_build calls + if (i == 17) return rmaxever; // ghost atom distance for < maxstrain + if (i == 18) return rmaxeverbig; // ghost atom distance for any strain + if (i == 19) return compute_vector(14); // count of ghost atoms not found + if (i == 20) return compute_vector(15); // count of lost bond partners + if (i == 21) return compute_vector(16); // ave bias coeff of long bonds + if (i == 22) return compute_vector(17); // count of bias overlaps + if (i == 23) return compute_vector(18); // count of non-matching bias coeffs + + error->all(FLERR,"Invalid query to fix hyper/local"); + + return 0.0; +} + +/* ---------------------------------------------------------------------- + memory usage of per-atom and per-bond arrays +------------------------------------------------------------------------- */ + +double FixHyperLocal::memory_usage() +{ + int nmax = atom->nmax; + double bytes = 2*nmax * sizeof(int); // numbond, maxstrain_bondindex + bytes = 2*nmax * sizeof(double); // maxstrain, maxstrain_region + bytes += maxbondperatom*nmax * sizeof(OneBond); // bonds + bytes += 3*maxold * sizeof(double); // xold + bytes += maxold * sizeof(tagint); // tagold + bytes += maxold * sizeof(int); // old2now + return bytes; +} diff --git a/src/REPLICA/fix_hyper_local.h b/src/REPLICA/fix_hyper_local.h new file mode 100644 index 0000000000000000000000000000000000000000..9fe4d03fb9c3ff121ab4e6fc38a51930723c7419 --- /dev/null +++ b/src/REPLICA/fix_hyper_local.h @@ -0,0 +1,168 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef FIX_CLASS + +FixStyle(hyper/local,FixHyperLocal) + +#else + +#ifndef LMP_FIX_HYPER_LOCAL_H +#define LMP_FIX_HYPER_LOCAL_H + +#include "fix_hyper.h" + +namespace LAMMPS_NS { + +class FixHyperLocal : public FixHyper { + public: + FixHyperLocal(class LAMMPS *, int, char **); + ~FixHyperLocal(); + int setmask(); + void init(); + void init_list(int, class NeighList *); + void setup_pre_neighbor(); + void setup_pre_reverse(int, int); + void pre_neighbor(); + void pre_reverse(int, int); + void min_pre_neighbor(); + double compute_scalar(); + double compute_vector(int); + double query(int); + + int pack_forward_comm(int, int *, double *, int, int *); + void unpack_forward_comm(int, int, double *); + int pack_reverse_comm(int, int, double *); + void unpack_reverse_comm(int, int *, double *); + + void grow_arrays(int); + void copy_arrays(int, int, int); + int pack_exchange(int, double *); + int unpack_exchange(int, double *); + + double memory_usage(); + + // extra methods visible to callers + + void init_hyper(); + void build_bond_list(int); + + private: + int me; + double cutbond,qfactor,vmax,tequil,dcut; + double alpha_user; // timescale to apply boostostat (time units) + double alpha; // unitless dt/alpha_user + double boosttarget; // target value of boost + int histoflag; + int lostbond,lostbond_partner; + double lostbond_coeff; + int checkbias,checkbias_every,checkbias_flag,checkbias_count; + int checkcoeff,checkcoeff_every,checkcoeff_flag,checkcoeff_count; + + int setupflag; // 1 during setup, 0 during run + int firstflag; // set for first time bond_build takes place + int nostrainyet; // 1 until maxstrain is first computed + + int nboost_running,nobias_running; + int nbondbuild; + double time_bondbuild; + bigint starttime; + double sumboostcoeff; // sum of aveboost at every timestep + int allbonds; // sum of bond count on this step + double allboost; // sum of boostcoeff on all bonds on this step + + int nnewbond; // running tally of number of new bonds created + int maxbondperatom; // max # of bonds any atom ever has + int commflag; // flag for communication mode + int nevent; // # of events that trigger bond rebuild + int nevent_atom; // # of atoms that experienced an event + double cutbondsq,dcutsq; + double beta,t_hyper,invqfactorsq; + double mybias; + double maxbondlen; // cummulative max length of any bond + double maxdriftsq; // max distance any atom drifts from original pos + double maxboostcoeff; // cummulative max boost coeff for any bond + double minboostcoeff; // cummulative min boost coeff for any bond + double rmaxever,rmaxeverbig; + int ghost_toofar; + + // extra timers + + //double timefirst,timesecond,timethird,timefourth; + //double timefifth,timesixth,timeseventh,timetotal; + + // data structs for per-atom and per-bond info + // all of these are for current owned and ghost atoms + // except list and old2now are for atom indices at time of last bond build + + class NeighList *list; // full neigh list up to Dcut distance + // created only when bonds are rebuilt + + int *old2now; // o2n[i] = current local index of old atom i + // stored for old owned and ghost atoms + // I = old index when bonds were last created + // old indices are stored in old neighbor list + + double **xold; // coords of owned+ghost atoms when bonds created + tagint *tagold; // global IDs of owned+ghost atoms when b created + + int maxold; // allocated size of old2now + int maxbond; // allocated size of bonds + int old_nall; // nlocal+nghost when old2now was last setup + + struct OneBond { // single IJ bond, atom I is owner + double r0; // original relaxed bond length + double boostcoeff; // boost coefficient + tagint jtag; // global index of J atom in bond IJ + int j; // local index of J atom in bond IJ + }; + + struct OneBond **bonds; // 2d array of bonds for owned atoms + int *numbond; // number of bonds for each owned atom + + double *maxstrain; // max-strain of any bond atom I is part of + // for owned and ghost atoms + double *maxstrain_region; // max-strain of any neighbor atom J of atom I + // for owned and ghost atoms + int *maxstrain_bondindex; // index of max-strain bond of each atom I + // just for owned atoms + tagint *biasflag; // atoms in biased bonds marked with bond partner + // for owned and ghost atoms + + // list of boosted bonds that this proc will bias + + int maxboost; // allocated size of boost list + int nboost; // # of boosted bonds I own + int *boost; // index of atom I in each boosted bond + + // histogramming of bond boost cooeficients + + int histo_flag,histo_every,histo_count,histo_print,histo_steps; + double histo_delta,invhisto_delta,histo_lo; + bigint *histo,*allhisto; +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Illegal ... command + +Self-explanatory. Check the input script syntax and compare to the +documentation for the command. You can use -echo screen as a +command-line option when running LAMMPS to see the offending line. + +*/ diff --git a/src/REPLICA/hyper.cpp b/src/REPLICA/hyper.cpp new file mode 100644 index 0000000000000000000000000000000000000000..89409d63fcd995a961b5ff09073f2cfb2f312818 --- /dev/null +++ b/src/REPLICA/hyper.cpp @@ -0,0 +1,535 @@ +/* ---------------------------------------------------------------------- + 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 <cmath> +#include <cstdlib> +#include <cstring> +#include "hyper.h" +#include "update.h" +#include "atom.h" +#include "domain.h" +#include "region.h" +#include "integrate.h" +#include "min.h" +#include "force.h" +#include "neighbor.h" +#include "modify.h" +#include "compute_event_displace.h" +#include "fix_hyper.h" +#include "fix_event_hyper.h" +#include "output.h" +#include "dump.h" +#include "finish.h" +#include "timer.h" +#include "memory.h" +#include "error.h" + +using namespace LAMMPS_NS; + +enum{NOHYPER,GLOBAL,LOCAL}; + +/* ---------------------------------------------------------------------- */ + +Hyper::Hyper(LAMMPS *lmp) : + Pointers(lmp), dumplist(NULL) +{} + +/* ---------------------------------------------------------------------- + perform hyperdynamics simulation +------------------------------------------------------------------------- */ + +void Hyper::command(int narg, char **arg) +{ + MPI_Comm_rank(world,&me); + MPI_Comm_size(world,&nprocs); + + // error checks + + if (domain->box_exist == 0) + error->all(FLERR,"Hyper command before simulation box is defined"); + + if (narg < 4) error->all(FLERR,"Illegal hyper command"); + + int nsteps = force->inumeric(FLERR,arg[0]); + t_event = force->inumeric(FLERR,arg[1]); + + char *id_fix = new char[strlen(arg[2])+1]; + strcpy(id_fix,arg[2]); + + char *id_compute = new char[strlen(arg[3])+1]; + strcpy(id_compute,arg[3]); + + options(narg-4,&arg[4]); + + // total # of timesteps must be multiple of t_event + + if (t_event <= 0) + error->all(FLERR,"Invalid t_event in hyper command"); + if (nsteps % t_event) + error->all(FLERR,"Hyper nsteps must be multiple of t_event"); + if (rebond < 0) + error->all(FLERR,"Invalid rebond in hyper command"); + if (rebond && rebond % t_event) + error->all(FLERR,"Hyper rebond must be multiple of t_event"); + + // FixHyper class performs global or local hyperdynamics + + int hyperenable,hyperstyle; + + if (strcmp(id_fix,"NULL") == 0) { + hyperenable = 0; + hyperstyle = NOHYPER; + } else { + int ifix = modify->find_fix(id_fix); + if (ifix < 0) error->all(FLERR,"Could not find fix ID for hyper"); + fix_hyper = (FixHyper *) modify->fix[ifix]; + int dim; + int *hyperflag = (int *) fix_hyper->extract("hyperflag",dim); + if (hyperflag == NULL || *hyperflag == 0) + error->all(FLERR,"Hyper fix is not a valid hyperdynamics fix"); + if (*hyperflag == 1) hyperstyle = GLOBAL; + if (*hyperflag == 2) hyperstyle = LOCAL; + hyperenable = 1; + } + + // create FixEventHyper class to store event and pre-quench states + + char **args = new char*[3]; + args[0] = (char *) "hyper_event"; + args[1] = (char *) "all"; + args[2] = (char *) "EVENT/HYPER"; + modify->add_fix(3,args); + fix_event = (FixEventHyper *) modify->fix[modify->nfix-1]; + delete [] args; + + // create Finish for timing output + + finish = new Finish(lmp); + + // assign FixEventHyper to event-detection compute + // necessary so it will know atom coords at last event + + int icompute = modify->find_compute(id_compute); + if (icompute < 0) error->all(FLERR,"Could not find compute ID for hyper"); + compute_event = (ComputeEventDisplace *) modify->compute[icompute]; + compute_event->reset_extra_compute_fix("hyper_event"); + + // reset reneighboring criteria since will perform minimizations + + neigh_every = neighbor->every; + neigh_delay = neighbor->delay; + neigh_dist_check = neighbor->dist_check; + + if (neigh_every != 1 || neigh_delay != 0 || neigh_dist_check != 1) { + if (me == 0) + error->warning(FLERR,"Resetting reneighboring criteria during hyper"); + } + + neighbor->every = 1; + neighbor->delay = 0; + neighbor->dist_check = 1; + + // initialize hyper as if one long dynamics run + + update->whichflag = 1; + update->nsteps = nsteps; + update->beginstep = update->firststep = update->ntimestep; + update->endstep = update->laststep = update->firststep + nsteps; + if (update->laststep < 0) + error->all(FLERR,"Too many timesteps"); + + lmp->init(); + + // init minimizer settings and minimizer itself + + update->etol = etol; + update->ftol = ftol; + update->max_eval = maxeval; + + // cannot use hyper with a changing box + // removing this restriction would require saving/restoring box params + + if (domain->box_change) + error->all(FLERR,"Cannot use hyper with a changing box"); + + // cannot use hyper with time-dependent fixes or regions + + for (int i = 0; i < modify->nfix; i++) + if (modify->fix[i]->time_depend) + error->all(FLERR,"Cannot use hyper with a time-dependent fix defined"); + + for (int i = 0; i < domain->nregion; i++) + if (domain->regions[i]->dynamic_check()) + error->all(FLERR,"Cannot use hyper with a time-dependent region defined"); + + // perform hyperdynamics simulation + + timer->init(); + timer->barrier_start(); + time_start = timer->get_wall(Timer::TOTAL); + + nbuild = ndanger = 0; + time_dynamics = time_quench = 0.0; + + if (hyperenable) fix_hyper->init_hyper(); + + timer->barrier_start(); + time_start = timer->get_wall(Timer::TOTAL); + + // perform initial minimization and bond list creation + + int nevent = 0; + int nevent_atoms = 0; + + fix_event->store_state_quench(); + quench(1); + if (dumpflag) + for (int idump = 0; idump < ndump; idump++) + output->dump[dumplist[idump]]->write(); + fix_event->store_event(); + if (hyperenable) fix_hyper->build_bond_list(0); + fix_event->restore_state_quench(); + + // main loop: dynamics, store state, quench, check event, restore state + + int ecount; + int istep = 0; + + while (istep < nsteps) { + dynamics(t_event,time_dynamics); + fix_event->store_state_quench(); + quench(0); + + ecount = compute_event->all_events(); + + if (ecount) { + nevent++; + nevent_atoms += ecount; + + if (dumpflag) + for (int idump = 0; idump < ndump; idump++) + output->dump[dumplist[idump]]->write(); + fix_event->store_event(); + if (hyperenable) fix_hyper->build_bond_list(ecount); + + } else if (rebond && update->ntimestep % rebond == 0) { + fix_event->store_event(); + if (hyperenable) fix_hyper->build_bond_list(ecount); + } + + fix_event->restore_state_quench(); + istep = update->ntimestep - update->beginstep; + } + + nsteps = update->ntimestep - update->beginstep; + + // set total timers and counters so Finish() will process them + + timer->set_wall(Timer::TOTAL,time_start); + timer->barrier_stop(); + + timer->set_wall(Timer::DYNAMICS,time_dynamics); + timer->set_wall(Timer::QUENCH,time_quench); + + neighbor->ncalls = nbuild; + neighbor->ndanger = ndanger; + + update->nsteps = nsteps; + + if (me == 0) { + if (screen) fprintf(screen,"Final hyper stats ...\n\n"); + if (logfile) fprintf(logfile,"Final hyper stats ...\n\n"); + } + + // subset of quantities also available in fix hyper output + + int nevent_running = 0; + int nevent_atoms_running = 0; + double t_hyper = 0.0; + double avebonds = 0.0; + double maxdrift = 0.0; + double maxbondlen = 0.0; + double fraczero = 1.0; + + double nnewbond,avenboost,aveboostcoeff,maxboostcoeff,minboostcoeff; + double maxbondperatom,neighbondperbond,aveboostnow; + double tbondbuild,rmaxever,rmaxeverbig,allghost_toofar; + double lostbond,lostbondcoeff,biasoverlap,nonmatchbiascoeff; + + if (hyperenable) { + t_hyper = fix_hyper->query(1); + nevent_running = fix_hyper->query(2); + nevent_atoms_running = fix_hyper->query(3); + avebonds = fix_hyper->query(4); + maxdrift = fix_hyper->query(5); + maxbondlen = fix_hyper->query(6); + fraczero = fix_hyper->query(7); + + if (hyperstyle == LOCAL) { + nnewbond = fix_hyper->query(8); + maxbondperatom = fix_hyper->query(9); + avenboost = fix_hyper->query(10); + aveboostcoeff = fix_hyper->query(11); + maxboostcoeff = fix_hyper->query(12); + minboostcoeff = fix_hyper->query(13); + neighbondperbond = fix_hyper->query(14); + aveboostnow = fix_hyper->query(15); + tbondbuild = fix_hyper->query(16); + rmaxever = fix_hyper->query(17); + rmaxeverbig = fix_hyper->query(18); + allghost_toofar = fix_hyper->query(19); + lostbond = fix_hyper->query(20); + lostbondcoeff = fix_hyper->query(21); + biasoverlap = fix_hyper->query(22); + nonmatchbiascoeff = fix_hyper->query(23); + } + } + + if (me == 0) { + if (screen) { + fprintf(screen,"Cummulative quantities for fix hyper:\n"); + fprintf(screen," hyper time = %g\n",t_hyper); + fprintf(screen," time boost factor = %g\n",t_hyper/(nsteps*update->dt)); + fprintf(screen," event timesteps = %d\n",nevent_running); + fprintf(screen," # of atoms in events = %d\n",nevent_atoms_running); + fprintf(screen,"Quantities for this hyper run:\n"); + fprintf(screen," event timesteps = %d\n",nevent); + fprintf(screen," # of atoms in events = %d\n",nevent_atoms); + fprintf(screen," max length of any bond = %g\n",maxbondlen); + fprintf(screen," max drift distance of any atom = %g\n",maxdrift); + fprintf(screen," fraction of steps & bonds with zero bias = %g\n", + fraczero); + fprintf(screen,"Current quantities:\n"); + fprintf(screen," ave bonds/atom = %g\n",avebonds); + + if (hyperstyle == LOCAL) { + fprintf(screen,"Cummulative quantities specific to fix hyper/local:\n"); + fprintf(screen," # of new bonds formed = %g\n",nnewbond); + fprintf(screen," max bonds/atom = %g\n",maxbondperatom); + fprintf(screen,"Quantities for this hyper run specific to " + "fix hyper/local:\n"); + fprintf(screen," ave boosted bonds/step = %g\n",avenboost); + fprintf(screen," ave boost coeff of all bonds = %g\n",aveboostcoeff); + fprintf(screen," max boost coeff of any bond = %g\n",maxboostcoeff); + fprintf(screen," min boost coeff of any bond = %g\n",minboostcoeff); + fprintf(screen," max dist from my box of any " + "non-maxstrain bond ghost atom = %g\n",rmaxever); + fprintf(screen," max dist from my box of any bond ghost atom = %g\n", + rmaxeverbig); + fprintf(screen," count of bond ghost neighbors " + "not found on reneighbor steps = %g\n",allghost_toofar); + fprintf(screen," lost bond partners = %g\n",lostbond); + fprintf(screen," ave bias coeff for lost bond partners = %g\n", + lostbondcoeff); + fprintf(screen," bias overlaps = %g\n",biasoverlap); + fprintf(screen," non-matching bias coeffs = %g\n",nonmatchbiascoeff); + fprintf(screen," CPU time for bond builds = %g\n",tbondbuild); + fprintf(screen,"Current quantities specific to fix hyper/local:\n"); + fprintf(screen," neighbor bonds/bond = %g\n",neighbondperbond); + fprintf(screen," ave boost coeff for all bonds = %g\n",aveboostnow); + } + fprintf(screen,"\n"); + } + + if (logfile) { + fprintf(logfile,"Cummulative quantities for fix hyper:\n"); + fprintf(logfile," hyper time = %g\n",t_hyper); + fprintf(logfile," event timesteps = %d\n",nevent_running); + fprintf(logfile," # of atoms in events = %d\n",nevent_atoms_running); + fprintf(logfile,"Quantities for this hyper run:\n"); + fprintf(logfile," event timesteps = %d\n",nevent); + fprintf(logfile," # of atoms in events = %d\n",nevent_atoms); + fprintf(logfile," max length of any bond = %g\n",maxbondlen); + fprintf(logfile," max drift distance of any atom = %g\n",maxdrift); + fprintf(logfile," fraction of steps & bonds with zero bias = %g\n", + fraczero); + fprintf(logfile,"Current quantities:\n"); + fprintf(logfile," ave bonds/atom = %g\n",avebonds); + + if (hyperstyle == LOCAL) { + fprintf(logfile,"Cummulative quantities specific tofix hyper/local:\n"); + fprintf(logfile," # of new bonds formed = %g\n",nnewbond); + fprintf(logfile," max bonds/atom = %g\n",maxbondperatom); + fprintf(logfile,"Quantities for this hyper run specific to " + "fix hyper/local:\n"); + fprintf(logfile," ave boosted bonds/step = %g\n",avenboost); + fprintf(logfile," ave boost coeff of all bonds = %g\n",aveboostcoeff); + fprintf(logfile," max boost coeff of any bond = %g\n",maxboostcoeff); + fprintf(logfile," min boost coeff of any bond = %g\n",minboostcoeff); + fprintf(logfile," max dist from my box of any " + "non-maxstrain bond ghost atom = %g\n",rmaxever); + fprintf(logfile," max dist from my box of any bond ghost atom = %g\n", + rmaxeverbig); + fprintf(logfile," count of ghost bond neighbors " + "not found on reneighbor steps = %g\n",allghost_toofar); + fprintf(logfile," lost bond partners = %g\n",lostbond); + fprintf(logfile," ave bias coeff for lost bond partners = %g\n", + lostbondcoeff); + fprintf(logfile," bias overlaps = %g\n",biasoverlap); + fprintf(logfile," non-matching bias coeffs = %g\n",nonmatchbiascoeff); + fprintf(logfile," CPU time for bond builds = %g\n",tbondbuild); + fprintf(logfile,"Current quantities specific to fix hyper/local:\n"); + fprintf(logfile," neighbor bonds/bond = %g\n",neighbondperbond); + fprintf(logfile," ave boost coeff for all bonds = %g\n",aveboostnow); + } + fprintf(logfile,"\n"); + } + } + + // timing stats + + finish->end(4); + + update->whichflag = 0; + update->firststep = update->laststep = 0; + update->beginstep = update->endstep = 0; + + // reset reneighboring criteria + + neighbor->every = neigh_every; + neighbor->delay = neigh_delay; + neighbor->dist_check = neigh_dist_check; + + delete [] id_fix; + delete [] id_compute; + memory->destroy(dumplist); + delete finish; + modify->delete_fix("hyper_event"); + + compute_event->reset_extra_compute_fix(NULL); +} + +/* ---------------------------------------------------------------------- + short dynamics run +------------------------------------------------------------------------- */ + +void Hyper::dynamics(int nsteps, double & /* time_category */) +{ + update->whichflag = 1; + update->nsteps = nsteps; + + // full init works + // need to try partial init or setup + + lmp->init(); + update->integrate->setup(0); + // this may be needed if don't do full init + //modify->addstep_compute_all(update->ntimestep); + bigint ncalls = neighbor->ncalls; + + timer->barrier_start(); + update->integrate->run(nsteps); + timer->barrier_stop(); + time_dynamics += timer->get_wall(Timer::TOTAL); + + nbuild += neighbor->ncalls - ncalls; + ndanger += neighbor->ndanger; + + update->integrate->cleanup(); + finish->end(0); +} + +/* ---------------------------------------------------------------------- + quench minimization + flag = 1 to trigger output of memory in setup() call +------------------------------------------------------------------------- */ + +void Hyper::quench(int flag) +{ + bigint ntimestep_hold = update->ntimestep; + bigint endstep_hold = update->endstep; + + // need to change whichflag so that minimize->setup() calling + // modify->setup() will call fix->min_setup() + + update->whichflag = 2; + update->nsteps = maxiter; + update->endstep = update->laststep = update->firststep + maxiter; + if (update->laststep < 0) + error->all(FLERR,"Too many iterations"); + update->restrict_output = 1; + + // full init works + + lmp->init(); + update->minimize->setup(flag); + + // partial init does not work + + //modify->addstep_compute_all(update->ntimestep); + //update->minimize->setup_minimal(1); + + timer->barrier_start(); + update->minimize->run(maxiter); + timer->barrier_stop(); + time_quench += timer->get_wall(Timer::TOTAL); + + update->minimize->cleanup(); + finish->end(0); + + // reset timestep as if quench did not occur + // clear timestep storage from computes, since now invalid + + update->restrict_output = 0; + update->ntimestep = ntimestep_hold; + update->endstep = update->laststep = endstep_hold; + for (int i = 0; i < modify->ncompute; i++) + if (modify->compute[i]->timeflag) modify->compute[i]->clearstep(); +} + +/* ---------------------------------------------------------------------- + parse optional parameters at end of hyper input line +------------------------------------------------------------------------- */ + +void Hyper::options(int narg, char **arg) +{ + // set defaults + + etol = 1.0e-4; + ftol = 1.0e-4; + maxiter = 40; + maxeval = 50; + dumpflag = 0; + ndump = 0; + dumplist = NULL; + rebond = 0; + + int iarg = 0; + while (iarg < narg) { + if (strcmp(arg[iarg],"min") == 0) { + if (iarg+5 > narg) error->all(FLERR,"Illegal hyper command"); + etol = force->numeric(FLERR,arg[iarg+1]); + ftol = force->numeric(FLERR,arg[iarg+2]); + maxiter = force->inumeric(FLERR,arg[iarg+3]); + maxeval = force->inumeric(FLERR,arg[iarg+4]); + if (maxiter < 0) error->all(FLERR,"Illegal hyper command"); + iarg += 5; + + } else if (strcmp(arg[iarg],"dump") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal hyper command"); + dumpflag = 1; + int idump = output->find_dump(arg[iarg+1]); + if (idump < 0) + error->all(FLERR,"Dump ID in hyper command does not exist"); + memory->grow(dumplist,ndump+1,"hyper:dumplist"); + dumplist[ndump++] = idump; + iarg += 2; + + } else if (strcmp(arg[iarg],"rebond") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal hyper command"); + rebond = force->inumeric(FLERR,arg[iarg+1]); + iarg += 2; + + } else error->all(FLERR,"Illegal hyper command"); + } +} diff --git a/src/REPLICA/hyper.h b/src/REPLICA/hyper.h new file mode 100644 index 0000000000000000000000000000000000000000..1b05172bcf1d2c6ce4405759e7c794786069121a --- /dev/null +++ b/src/REPLICA/hyper.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 COMMAND_CLASS + +CommandStyle(hyper,Hyper) + +#else + +#ifndef LMP_HYPER_H +#define LMP_HYPER_H + +#include "pointers.h" + +namespace LAMMPS_NS { + +class Hyper : protected Pointers { + public: + Hyper(class LAMMPS *); + ~Hyper() {} + void command(int, char **); + + private: + int me,nprocs; + int t_event; + double etol,ftol; + int maxiter,maxeval; + int stepmode,dumpflag,ndump,rebond; + int *dumplist; + + int neigh_every,neigh_delay,neigh_dist_check; + int quench_reneighbor; + bigint nbuild,ndanger; + + double time_dynamics,time_quench; + double time_start; + + class FixHyper *fix_hyper; + class FixEventHyper *fix_event; + class ComputeEventDisplace *compute_event; + class Finish *finish; + + void dynamics(int, double &); + void quench(int flag); + void options(int, char **); +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +*/