diff --git a/doc/src/Section_commands.txt b/doc/src/Section_commands.txt index 0d46a01424ff0c986e5f9137b995a65ab11cbc3a..3ac9c05e5c3d78fdc871c8f37b1fc24a1c2d3a53 100644 --- a/doc/src/Section_commands.txt +++ b/doc/src/Section_commands.txt @@ -715,8 +715,10 @@ package"_Section_start.html#start_3. "nve/manifold/rattle"_fix_nve_manifold_rattle.html, "nvk"_fix_nvk.html, "nvt/manifold/rattle"_fix_nvt_manifold_rattle.html, +"nvt/uef"_fix_nh_uef.html, "nph/eff"_fix_nh_eff.html, "npt/eff"_fix_nh_eff.html, +"npt/uef"_fix_nh_uef.html, "nve/eff"_fix_nve_eff.html, "nvt/eff"_fix_nh_eff.html, "nvt/sllod/eff"_fix_nvt_sllod_eff.html, @@ -856,6 +858,7 @@ package"_Section_start.html#start_3. "meso/t/atom"_compute_meso_t_atom.html, "pe/tally"_compute_tally.html, "pe/mol/tally"_compute_tally.html, +"pressure/uef"_compute_pressure_uef.html, "saed"_compute_saed.html, "smd/contact/radius"_compute_smd_contact_radius.html, "smd/damage"_compute_smd_damage.html, @@ -884,6 +887,7 @@ package"_Section_start.html#start_3. "temp/deform/eff"_compute_temp_deform_eff.html, "temp/region/eff"_compute_temp_region_eff.html, "temp/rotate"_compute_temp_rotate.html, +"temp/uef"_compute_temp_uef.html, "xrd"_compute_xrd.html :tb(c=6,ea=c) :line diff --git a/doc/src/Section_packages.txt b/doc/src/Section_packages.txt index d9a9fb4163a3d0186b2d803195b72be0e57ccf3d..45cdd8ff482ca10d076e325d7e71f0c379dc8cf7 100644 --- a/doc/src/Section_packages.txt +++ b/doc/src/Section_packages.txt @@ -150,6 +150,7 @@ Package, Description, Doc page, Example, Library "USER-SMTBQ"_#USER-SMTBQ, second moment tight binding QEq potential,"pair_style smtbq"_pair_smtbq.html, USER/smtbq, - "USER-SPH"_#USER-SPH, smoothed particle hydrodynamics,"SPH User Guide"_PDF/SPH_LAMMPS_userguide.pdf, USER/sph, - "USER-TALLY"_#USER-TALLY, pairwise tally computes,"compute XXX/tally"_compute_tally.html, USER/tally, - +"USER-UEF"_#USER-UEF, NEMD under extensional flow,"fix nvt/uef"_fix_nh_uef.html, USER/uef, - "USER-VTK"_#USER-VTK, dump output via VTK, "compute vtk"_dump_vtk.html, -, ext :tb(ea=c,ca1=l) :line @@ -2770,6 +2771,33 @@ examples/USER/tally :ul :line +UEF package :link(UEF),h4 + +[Contents:] + +A fix style for the integration of the equations of motion under +extensional flow with proper boundary conditions, as well +as several supporting compute styles and an output option. + +[Install or un-install:] + +make yes-user-uef +make machine :pre + +make no-user-uef +make machine :pre + +[Supporting info:] + +src/USER-UEF: filenames -> commands +"fix nvt/uef"_fix_nh_uef.html +"compute pressure/uef"_compute_pressure_uef.html +"compute temp/uef"_compute_temp_uef.html +"dump cfg/uef"_dump_cfg_uef.html +examples/uef :ul + +:line + USER-VTK package :link(USER-VTK),h4 [Contents:] diff --git a/doc/src/compute_temp_uef.txt b/doc/src/compute_temp_uef.txt new file mode 100644 index 0000000000000000000000000000000000000000..33f847af355415300d16e4689c17c063c3cdb9ce --- /dev/null +++ b/doc/src/compute_temp_uef.txt @@ -0,0 +1,52 @@ +"LAMMPS WWW Site"_lws - "LAMMPS Documentation"_ld - "LAMMPS Commands"_lc :c + +:link(lws,http://lammps.sandia.gov) +:link(ld,Manual.html) +:link(lc,Section_commands.html#comm) + +:line + +compute temp command :h3 +compute temp/kk command :h3 + +[Syntax:] + +compute ID group-ID temp :pre + +ID, group-ID are documented in "compute"_compute.html command +temp = style name of this compute command :ul + +[Examples:] + +compute 1 all temp/uef + +[Description:] + +This command is used to compute the kinetic energy tensor in +the correct reference frame when the USER-UEF package is used. +It is not necessary to use this command to compute the scalar +value of the temperature. A "compute temp"_compute_temp.html +may be used for that purpose. + +[Output info:] + +Output information for this command can be found in the +documentation for "compute temp"_compute_temp.html. + +[Restrictions:] + +This fix is part of the USER-UEF package. It is only enabled if +LAMMPS was built with that package. See the +"Making LAMMPS"_Section_start.html#start-3 section for more info. + + +This command can only be used when "fix nvt/uef"_fix_nh_uef.html +or "fix npt/uef"_fix_nh_uef.html is active. + +[Related commands:] +"compute temp"_compute_temp.html, +"fix nvt/uef"_fix_nh_uef.html, +"compute pressure/uef"_compute_pressure_uef.html + + +[Default:] none diff --git a/doc/src/fix_nh_uef.txt b/doc/src/fix_nh_uef.txt new file mode 100644 index 0000000000000000000000000000000000000000..38d01edccf8244deebf62367af0afc92f4e08073 --- /dev/null +++ b/doc/src/fix_nh_uef.txt @@ -0,0 +1,715 @@ +<"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 nvt/uef command :h3 +fix npt/uef command :h3 + +[Syntax:] + +fix ID group-ID style_name erate eps_x eps_y temp Tstart Tstop Tdamp keyword value ... :pre + +ID, group-ID are documented in "fix"_fix.html command :ulb,l +style_name = {nvt/uef} or {npt/uef} :l +Tstart, Tstop, and Tdamp are documented in the "fix_npt"_fix_nh.html command :l +edot_x and edot_y are the strain rates in the x and y directions (1/(time units)) :l +one or more keyword/value pairs may be appended :l +keyword = {ext} or {strain} or {iso} or {x} or {y} or {z} or {tchain} or {pchain} or {tloop} or {ploop} or {mtk} + {ext} value = {x} or {y} or {z} or {xy} or {yz} or {xz} = external dimensions + This keyword sets the external dimensions used to calculate the scalar pressure + {strain} values = e_x e_y = initial strain + Use of this keyword is usually not necessary, but may be needed to resume a run with a data file. + The {iso}, {x}, {y}, {z}, {tchain}, {pchain}, {tloop}, {ploop}, and {mtk} keywords are documented in the "fix_npt"_fix_nh.html command. :pre +:ule + +[Examples:] + +fix uniax_nvt all nvt/uef temp 400 400 100 erate 0.00001 -0.000005 +fix biax_nvt all nvt/uef temp 400 400 100 erate 0.000005 0.000005 +fix uniax_npt all npt/uef temp 400 400 300 iso 1 1 3000 erate 0.00001 -0.000005 ext yz +fix biax_npt all npt/uef temp 400 400 100 erate 0.00001 -0.000005 :pre + +[Description:] + + +This fix is used to simulate non-equilibrium molecular dynamics (NEMD) +under diagonal flow fields, including uniaxial and biaxial flow. +Simulations under extensional flow may be carried out for an +indefinite amount of time. It is an implementation of the boundary +conditions from "(Dobson)"_#Dobson, and also uses numerical lattice reduction +as was proposed by "(Hunt)"_#Hunt. The lattice reduction algorithm is from +"(Semaev)"_Semaev. The package is intended for simulations of +homogeneous flows, and integrates the SLLOD equations of motion, +originally proposed by Hoover and Ladd (see "(Evans and Morriss)"_#Sllod). + +NOTE: Due to an instability in the SLLOD equations under extension, +"fix_momentum"_fix_momentum.html should be used to regularly reset the +linear momentum. + +The boundary conditions require a simulation box that does not have a +consistent alignment relative to the applied flow field. Since LAMMPS +utilizes an upper-triangular simulation box, it is not possible to express +the evolving simulation box in the same coordinate system as the flow field. +This fix keeps track of two coordinate systems: the flow frame, and the +upper triangular LAMMPS frame. The coordinate systems are related to +each other through the QR decomposition, as is illustrated in the image below. + +image + +During most molecular dynamics operations, the system is represented in the +LAMMPS frame. Only when the positions and velocities are updated is the system +rotated to the flow frame, and it is rotated back to the LAMMPS frame +immediately afterwards. For this reason, all vector-valued quantities +(except for the tensors from compute pressure/uef and compute temp/uef) will +be computed in the LAMMPS frame. Rotationally invariant scalar quantities like +the temperature and hydrostatic pressure, on the other hand, will be computed +correctly. Additionally, the system is in the LAMMPS frame during all of the +output steps, and therefore trajectory files made using the dump command +will be in the LAMMPS frame unless the dump cfg/uef command is used. + +:line + +Temperature control is achieved with the default Nose-Hoover style +thermostat documented in "fix_npt"_fix_nh.html. When this fix is active, +only the peculiar velocity of each atom is stored, defined as the velocity +relative to the streaming velocity. This is in contrast to +"fix_nvt/sllod"_fix_nvt_sllod.html, which uses a lab-frame velocity, and +removes the contribution from the streaming velocity in order to compute +the temperature. + +Pressure control is achieved using the default Nose-Hoover barostat documented +in "fix_npt"_fix_npt.html. There are two ways to control the pressure using this +fix. The first method involves using the {ext} keyword along with the {iso} pressure +style. With this method, the pressure is controlled by scaling the simulation box +isotropically to achieve the average pressure in the directions specified by {ext}. +For example, if {ext xy} is used, the average pressure (Pxx+Pyy)/2 will be controlled. + +This command will control the total hydrostatic pressure under uniaxial tension: + +fix f1 all npt/uef temp 0.7 0.7 0.5 iso 1 1 5 erate -0.5 -0.5 ext xyz :pre + +This command will control the average stress in compression directions, which would +correspond to free surfaces for fiber drawing, under uniaxial tension: + +fix f2 all npt/uef temp 0.7 0.7 0.5 iso 1 1 5 erate -0.5 -0.5 ext xy :pre + +The second method for pressure control involves setting the normal stresses using +the x, y , and/or z keywords. When using this method, the same pressure must be +specified via {Pstart} and {Pstop} for all dimensions controlled. Any choice of +pressure conditions that would cause LAMMPS to compute a deviatoric stress are not +permissible and will result in an error. Additionally, all dimensions with +controlled stress must have the same applied strain rate. The {ext} keyword must be +set to the default value ({xyz}) when using this method. + +For example, the following commands will work: + +fix f3 all npt/uef temp 0.7 0.7 0.5 x 1 1 5 y 1 1 5 erate -0.5 -0.5 +fix f4 all npt/uef temp 0.7 0.7 0.5 z 1 1 5 erate 0.5 0.5 :pre + +The following commands will not work: + +fix f5 all npt/uef temp 0.7 0.7 0.5 x 1 1 5 z 1 1 5 erate -0.5 -0.5 +fix f6 all npt/uef temp 0.7 0.7 0.5 x 1 1 5 z 2 2 5 erate 0.5 0.5 :pre + +:line + + +[Restrictions:] + +Due to requirements of the boundary conditions, when the strain keyword +is unset, or set to zero, the initial simulation box must be cubic and +have style triclinic. If the box is initially of type ortho, use +"change_box"_change_box.html before invoking the fix. + +When this fix is applied, any orientation-dependent vector or +tensor-valued quantities computed, except for the tensors from +compute pressure/uef/compute temp/uef and coordinates from +dump cfg/uef, will not be in the same coordinate system as +the flow field. + +:link(Dobson) +[(Dobson)] Dobson, J Chem Phys, 141, 184103 (2014). + +:link(Hunt) +[(Hunt)] Hunt, Mol Simul, 42, 347 (2016). + +:link(Semaev) +[(Semaev)] Semaev, Cryptography and Lattices, 181 (2001). + +:link(Sllod) +[(Evans and Morriss)] Evans and Morriss, Phys Rev A, 30, 1528 (1984). + +These commands perform time integration on Nose-Hoover style +non-Hamiltonian equations of motion which are designed to generate +positions and velocities sampled from the canonical (nvt), +isothermal-isobaric (npt), and isenthalpic (nph) ensembles. This +updates the position and velocity for atoms in the group each +timestep. + +The thermostatting and barostatting is achieved by adding some dynamic +variables which are coupled to the particle velocities +(thermostatting) and simulation domain dimensions (barostatting). In +addition to basic thermostatting and barostatting, these fixes can +also create a chain of thermostats coupled to the particle thermostat, +and another chain of thermostats coupled to the barostat +variables. The barostat can be coupled to the overall box volume, or +to individual dimensions, including the {xy}, {xz} and {yz} tilt +dimensions. The external pressure of the barostat can be specified as +either a scalar pressure (isobaric ensemble) or as components of a +symmetric stress tensor (constant stress ensemble). When used +correctly, the time-averaged temperature and stress tensor of the +particles will match the target values specified by Tstart/Tstop and +Pstart/Pstop. + +The equations of motion used are those of Shinoda et al in +"(Shinoda)"_#nh-Shinoda, which combine the hydrostatic equations of +Martyna, Tobias and Klein in "(Martyna)"_#nh-Martyna with the strain +energy proposed by Parrinello and Rahman in +"(Parrinello)"_#nh-Parrinello. The time integration schemes closely +follow the time-reversible measure-preserving Verlet and rRESPA +integrators derived by Tuckerman et al in "(Tuckerman)"_#nh-Tuckerman. + +:line + +The thermostat parameters for fix styles {nvt} and {npt} is specified +using the {temp} keyword. Other thermostat-related keywords are +{tchain}, {tloop} and {drag}, which are discussed below. + +The thermostat is applied to only the translational degrees of freedom +for the particles. The translational degrees of freedom can also have +a bias velocity removed before thermostatting takes place; see the +description below. The desired temperature at each timestep is a +ramped value during the run from {Tstart} to {Tstop}. The {Tdamp} +parameter is specified in time units and determines how rapidly the +temperature is relaxed. For example, a value of 10.0 means to relax +the temperature in a timespan of (roughly) 10 time units (e.g. tau or +fmsec or psec - see the "units"_units.html command). The atoms in the +fix group are the only ones whose velocities and positions are updated +by the velocity/position update portion of the integration. + +NOTE: A Nose-Hoover thermostat will not work well for arbitrary values +of {Tdamp}. If {Tdamp} is too small, the temperature can fluctuate +wildly; if it is too large, the temperature will take a very long time +to equilibrate. A good choice for many models is a {Tdamp} of around +100 timesteps. Note that this is NOT the same as 100 time units for +most "units"_units.html settings. + +:line + +The barostat parameters for fix styles {npt} and {nph} is specified +using one or more of the {iso}, {aniso}, {tri}, {x}, {y}, {z}, {xy}, +{xz}, {yz}, and {couple} keywords. These keywords give you the +ability to specify all 6 components of an external stress tensor, and +to couple various of these components together so that the dimensions +they represent are varied together during a constant-pressure +simulation. + +Other barostat-related keywords are {pchain}, {mtk}, {ploop}, +{nreset}, {drag}, and {dilate}, which are discussed below. + +Orthogonal simulation boxes have 3 adjustable dimensions (x,y,z). +Triclinic (non-orthogonal) simulation boxes have 6 adjustable +dimensions (x,y,z,xy,xz,yz). The "create_box"_create_box.html, "read +data"_read_data.html, and "read_restart"_read_restart.html commands +specify whether the simulation box is orthogonal or non-orthogonal +(triclinic) and explain the meaning of the xy,xz,yz tilt factors. + +The target pressures for each of the 6 components of the stress tensor +can be specified independently via the {x}, {y}, {z}, {xy}, {xz}, {yz} +keywords, which correspond to the 6 simulation box dimensions. For +each component, the external pressure or tensor component at each +timestep is a ramped value during the run from {Pstart} to {Pstop}. +If a target pressure is specified for a component, then the +corresponding box dimension will change during a simulation. For +example, if the {y} keyword is used, the y-box length will change. If +the {xy} keyword is used, the xy tilt factor will change. A box +dimension will not change if that component is not specified, although +you have the option to change that dimension via the "fix +deform"_fix_deform.html command. + +Note that in order to use the {xy}, {xz}, or {yz} keywords, the +simulation box must be triclinic, even if its initial tilt factors are +0.0. + +For all barostat keywords, the {Pdamp} parameter operates like the +{Tdamp} parameter, determining the time scale on which pressure is +relaxed. For example, a value of 10.0 means to relax the pressure in +a timespan of (roughly) 10 time units (e.g. tau or fmsec or psec - see +the "units"_units.html command). + +NOTE: A Nose-Hoover barostat will not work well for arbitrary values +of {Pdamp}. If {Pdamp} is too small, the pressure and volume can +fluctuate wildly; if it is too large, the pressure will take a very +long time to equilibrate. A good choice for many models is a {Pdamp} +of around 1000 timesteps. However, note that {Pdamp} is specified in +time units, and that timesteps are NOT the same as time units for most +"units"_units.html settings. + +Regardless of what atoms are in the fix group (the only atoms which +are time integrated), a global pressure or stress tensor is computed +for all atoms. Similarly, when the size of the simulation box is +changed, all atoms are re-scaled to new positions, unless the keyword +{dilate} is specified with a {dilate-group-ID} for a group that +represents a subset of the atoms. This can be useful, for example, to +leave the coordinates of atoms in a solid substrate unchanged and +controlling the pressure of a surrounding fluid. This option should +be used with care, since it can be unphysical to dilate some atoms and +not others, because it can introduce large, instantaneous +displacements between a pair of atoms (one dilated, one not) that are +far from the dilation origin. Also note that for atoms not in the fix +group, a separate time integration fix like "fix nve"_fix_nve.html or +"fix nvt"_fix_nh.html can be used on them, independent of whether they +are dilated or not. + +:line + +The {couple} keyword allows two or three of the diagonal components of +the pressure tensor to be "coupled" together. The value specified +with the keyword determines which are coupled. For example, {xz} +means the {Pxx} and {Pzz} components of the stress tensor are coupled. +{Xyz} means all 3 diagonal components are coupled. Coupling means two +things: the instantaneous stress will be computed as an average of the +corresponding diagonal components, and the coupled box dimensions will +be changed together in lockstep, meaning coupled dimensions will be +dilated or contracted by the same percentage every timestep. The +{Pstart}, {Pstop}, {Pdamp} parameters for any coupled dimensions must +be identical. {Couple xyz} can be used for a 2d simulation; the {z} +dimension is simply ignored. + +:line + +The {iso}, {aniso}, and {tri} keywords are simply shortcuts that are +equivalent to specifying several other keywords together. + +The keyword {iso} means couple all 3 diagonal components together when +pressure is computed (hydrostatic pressure), and dilate/contract the +dimensions together. Using "iso Pstart Pstop Pdamp" is the same as +specifying these 4 keywords: + +x Pstart Pstop Pdamp +y Pstart Pstop Pdamp +z Pstart Pstop Pdamp +couple xyz :pre + +The keyword {aniso} means {x}, {y}, and {z} dimensions are controlled +independently using the {Pxx}, {Pyy}, and {Pzz} components of the +stress tensor as the driving forces, and the specified scalar external +pressure. Using "aniso Pstart Pstop Pdamp" is the same as specifying +these 4 keywords: + +x Pstart Pstop Pdamp +y Pstart Pstop Pdamp +z Pstart Pstop Pdamp +couple none :pre + +The keyword {tri} means {x}, {y}, {z}, {xy}, {xz}, and {yz} dimensions +are controlled independently using their individual stress components +as the driving forces, and the specified scalar pressure as the +external normal stress. Using "tri Pstart Pstop Pdamp" is the same as +specifying these 7 keywords: + +x Pstart Pstop Pdamp +y Pstart Pstop Pdamp +z Pstart Pstop Pdamp +xy 0.0 0.0 Pdamp +yz 0.0 0.0 Pdamp +xz 0.0 0.0 Pdamp +couple none :pre + +:line + +In some cases (e.g. for solids) the pressure (volume) and/or +temperature of the system can oscillate undesirably when a Nose/Hoover +barostat and thermostat is applied. The optional {drag} keyword will +damp these oscillations, although it alters the Nose/Hoover equations. +A value of 0.0 (no drag) leaves the Nose/Hoover formalism unchanged. +A non-zero value adds a drag term; the larger the value specified, the +greater the damping effect. Performing a short run and monitoring the +pressure and temperature is the best way to determine if the drag term +is working. Typically a value between 0.2 to 2.0 is sufficient to +damp oscillations after a few periods. Note that use of the drag +keyword will interfere with energy conservation and will also change +the distribution of positions and velocities so that they do not +correspond to the nominal NVT, NPT, or NPH ensembles. + +An alternative way to control initial oscillations is to use chain +thermostats. The keyword {tchain} determines the number of thermostats +in the particle thermostat. A value of 1 corresponds to the original +Nose-Hoover thermostat. The keyword {pchain} specifies the number of +thermostats in the chain thermostatting the barostat degrees of +freedom. A value of 0 corresponds to no thermostatting of the +barostat variables. + +The {mtk} keyword controls whether or not the correction terms due to +Martyna, Tuckerman, and Klein are included in the equations of motion +"(Martyna)"_#nh-Martyna. Specifying {no} reproduces the original +Hoover barostat, whose volume probability distribution function +differs from the true NPT and NPH ensembles by a factor of 1/V. Hence +using {yes} is more correct, but in many cases the difference is +negligible. + +The keyword {tloop} can be used to improve the accuracy of integration +scheme at little extra cost. The initial and final updates of the +thermostat variables are broken up into {tloop} substeps, each of +length {dt}/{tloop}. This corresponds to using a first-order +Suzuki-Yoshida scheme "(Tuckerman)"_#nh-Tuckerman. The keyword {ploop} +does the same thing for the barostat thermostat. + +The keyword {nreset} controls how often the reference dimensions used +to define the strain energy are reset. If this keyword is not used, +or is given a value of zero, then the reference dimensions are set to +those of the initial simulation domain and are never changed. If the +simulation domain changes significantly during the simulation, then +the final average pressure tensor will differ significantly from the +specified values of the external stress tensor. A value of {nstep} +means that every {nstep} timesteps, the reference dimensions are set +to those of the current simulation domain. + +The {scaleyz}, {scalexz}, and {scalexy} keywords control whether or +not the corresponding tilt factors are scaled with the associated box +dimensions when barostatting triclinic periodic cells. The default +values {yes} will turn on scaling, which corresponds to adjusting the +linear dimensions of the cell while preserving its shape. Choosing +{no} ensures that the tilt factors are not scaled with the box +dimensions. See below for restrictions and default values in different +situations. In older versions of LAMMPS, scaling of tilt factors was +not performed. The old behavior can be recovered by setting all three +scale keywords to {no}. + +The {flip} keyword allows the tilt factors for a triclinic box to +exceed half the distance of the parallel box length, as discussed +below. If the {flip} value is set to {yes}, the bound is enforced by +flipping the box when it is exceeded. If the {flip} value is set to +{no}, the tilt will continue to change without flipping. Note that if +applied stress induces large deformations (e.g. in a liquid), this +means the box shape can tilt dramatically and LAMMPS will run less +efficiently, due to the large volume of communication needed to +acquire ghost atoms around a processor's irregular-shaped sub-domain. +For extreme values of tilt, LAMMPS may also lose atoms and generate an +error. + +The {fixedpoint} keyword specifies the fixed point for barostat volume +changes. By default, it is the center of the box. Whatever point is +chosen will not move during the simulation. For example, if the lower +periodic boundaries pass through (0,0,0), and this point is provided +to {fixedpoint}, then the lower periodic boundaries will remain at +(0,0,0), while the upper periodic boundaries will move twice as +far. In all cases, the particle trajectories are unaffected by the +chosen value, except for a time-dependent constant translation of +positions. + +If the {update} keyword is used with the {dipole} value, then the +orientation of the dipole moment of each particle is also updated +during the time integration. This option should be used for models +where a dipole moment is assigned to finite-size particles, +e.g. spheroids via use of the "atom_style hybrid sphere +dipole"_atom_style.html command. + +The default dipole orientation integrator can be changed to the +Dullweber-Leimkuhler-McLachlan integration scheme +"(Dullweber)"_#nh-Dullweber when using {update} with the value +{dipole/dlm}. This integrator is symplectic and time-reversible, +giving better energy conservation and allows slightly longer timesteps +at only a small additional computational cost. + +:line + +NOTE: Using a barostat coupled to tilt dimensions {xy}, {xz}, {yz} can +sometimes result in arbitrarily large values of the tilt dimensions, +i.e. a dramatically deformed simulation box. LAMMPS allows the tilt +factors to grow a small amount beyond the normal limit of half the box +length (0.6 times the box length), and then performs a box "flip" to +an equivalent periodic cell. See the discussion of the {flip} keyword +above, to allow this bound to be exceeded, if desired. + +The flip operation is described in more detail in the doc page for +"fix deform"_fix_deform.html. Both the barostat dynamics and the atom +trajectories are unaffected by this operation. However, if a tilt +factor is incremented by a large amount (1.5 times the box length) on +a single timestep, LAMMPS can not accomodate this event and will +terminate the simulation with an error. This error typically indicates +that there is something badly wrong with how the simulation was +constructed, such as specifying values of {Pstart} that are too far +from the current stress value, or specifying a timestep that is too +large. Triclinic barostatting should be used with care. This also is +true for other barostat styles, although they tend to be more +forgiving of insults. In particular, it is important to recognize that +equilibrium liquids can not support a shear stress and that +equilibrium solids can not support shear stresses that exceed the +yield stress. + +One exception to this rule is if the 1st dimension in the tilt factor +(x for xy) is non-periodic. In that case, the limits on the tilt +factor are not enforced, since flipping the box in that dimension does +not change the atom positions due to non-periodicity. In this mode, +if you tilt the system to extreme angles, the simulation will simply +become inefficient due to the highly skewed simulation box. + +NOTE: Unlike the "fix temp/berendsen"_fix_temp_berendsen.html command +which performs thermostatting but NO time integration, these fixes +perform thermostatting/barostatting AND time integration. Thus you +should not use any other time integration fix, such as "fix +nve"_fix_nve.html on atoms to which this fix is applied. Likewise, +fix nvt and fix npt should not normally be used on atoms that also +have their temperature controlled by another fix - e.g. by "fix +langevin"_fix_nh.html or "fix temp/rescale"_fix_temp_rescale.html +commands. + +See "this howto section"_Section_howto.html#howto_16 of the manual for +a discussion of different ways to compute temperature and perform +thermostatting and barostatting. + +:line + +These fixes compute a temperature and pressure each timestep. To do +this, the fix creates its own computes of style "temp" and "pressure", +as if one of these two sets of commands had been issued: + +compute fix-ID_temp group-ID temp +compute fix-ID_press group-ID pressure fix-ID_temp :pre + +compute fix-ID_temp all temp +compute fix-ID_press all pressure fix-ID_temp :pre + +See the "compute temp"_compute_temp.html and "compute +pressure"_compute_pressure.html commands for details. Note that the +IDs of the new computes are the fix-ID + underscore + "temp" or fix_ID ++ underscore + "press". For fix nvt, the group for the new computes +is the same as the fix group. For fix nph and fix npt, the group for +the new computes is "all" since pressure is computed for the entire +system. + +Note that these are NOT the computes used by thermodynamic output (see +the "thermo_style"_thermo_style.html command) with ID = {thermo_temp} +and {thermo_press}. This means you can change the attributes of this +fix's temperature or pressure via the +"compute_modify"_compute_modify.html command or print this temperature +or pressure during thermodynamic output via the "thermo_style +custom"_thermo_style.html command using the appropriate compute-ID. +It also means that changing attributes of {thermo_temp} or +{thermo_press} will have no effect on this fix. + +Like other fixes that perform thermostatting, fix nvt and fix npt can +be used with "compute commands"_compute.html that calculate a +temperature after removing a "bias" from the atom velocities. +E.g. removing the center-of-mass velocity from a group of atoms or +only calculating temperature on the x-component of velocity or only +calculating temperature for atoms in a geometric region. This is not +done by default, but only if the "fix_modify"_fix_modify.html command +is used to assign a temperature compute to this fix that includes such +a bias term. See the doc pages for individual "compute +commands"_compute.html to determine which ones include a bias. In +this case, the thermostat works in the following manner: the current +temperature is calculated taking the bias into account, bias is +removed from each atom, thermostatting is performed on the remaining +thermal degrees of freedom, and the bias is added back in. + +:line + +These fixes can be used with either the {verlet} or {respa} +"integrators"_run_style.html. When using one of the barostat fixes +with {respa}, LAMMPS uses an integrator constructed +according to the following factorization of the Liouville propagator +(for two rRESPA levels): + +:c,image(Eqs/fix_nh1.jpg) + +This factorization differs somewhat from that of Tuckerman et al, in +that the barostat is only updated at the outermost rRESPA level, +whereas Tuckerman's factorization requires splitting the pressure into +pieces corresponding to the forces computed at each rRESPA level. In +theory, the latter method will exhibit better numerical stability. In +practice, because Pdamp is normally chosen to be a large multiple of +the outermost rRESPA timestep, the barostat dynamics are not the +limiting factor for numerical stability. Both factorizations are +time-reversible and can be shown to preserve the phase space measure +of the underlying non-Hamiltonian equations of motion. + +NOTE: This implementation has been shown to conserve linear momentum +up to machine precision under NVT dynamics. Under NPT dynamics, +for a system with zero initial total linear momentum, the total +momentum fluctuates close to zero. It may occasionally undergo brief +excursions to non-negligible values, before returning close to zero. +Over long simulations, this has the effect of causing the center-of-mass +to undergo a slow random walk. This can be mitigated by resetting +the momentum at infrequent intervals using the +"fix momentum"_fix_momentum.html command. + +:line + +The fix npt and fix nph commands can be used with rigid bodies or +mixtures of rigid bodies and non-rigid particles (e.g. solvent). But +there are also "fix rigid/npt"_fix_rigid.html and "fix +rigid/nph"_fix_rigid.html commands, which are typically a more natural +choice. See the doc page for those commands for more discussion of +the various ways to do this. + +:line + +Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are +functionally the same as the corresponding style without the suffix. +They have been optimized to run faster, depending on your available +hardware, as discussed in "Section 5"_Section_accelerate.html +of the manual. The accelerated styles take the same arguments and +should produce the same results, except for round-off and precision +issues. + +These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, +USER-OMP and OPT packages, respectively. They are only enabled if +LAMMPS was built with those packages. See the "Making +LAMMPS"_Section_start.html#start_3 section for more info. + +You can specify the accelerated styles explicitly in your input script +by including their suffix, or you can use the "-suffix command-line +switch"_Section_start.html#start_6 when you invoke LAMMPS, or you can +use the "suffix"_suffix.html command in your input script. + +See "Section 5"_Section_accelerate.html of the manual for +more instructions on how to use the accelerated styles effectively. + +:line + +[Restart, fix_modify, output, run start/stop, minimize info:] + +These fixes writes the state of all the thermostat and barostat +variables to "binary restart files"_restart.html. See the +"read_restart"_read_restart.html command for info on how to re-specify +a fix in an input script that reads a restart file, so that the +operation of the fix continues in an uninterrupted fashion. + +The "fix_modify"_fix_modify.html {temp} and {press} options are +supported by these fixes. You can use them to assign a +"compute"_compute.html you have defined to this fix which will be used +in its thermostatting or barostatting procedure, as described above. +If you do this, note that the kinetic energy derived from the compute +temperature should be consistent with the virial term computed using +all atoms for the pressure. LAMMPS will warn you if you choose to +compute temperature on a subset of atoms. + +NOTE: If both the {temp} and {press} keywords are used in a single +thermo_modify command (or in two separate commands), then the order in +which the keywords are specified is important. Note that a "pressure +compute"_compute_pressure.html defines its own temperature compute as +an argument when it is specified. The {temp} keyword will override +this (for the pressure compute being used by fix npt), but only if the +{temp} keyword comes after the {press} keyword. If the {temp} keyword +comes before the {press} keyword, then the new pressure compute +specified by the {press} keyword will be unaffected by the {temp} +setting. + +The "fix_modify"_fix_modify.html {energy} option is supported by these +fixes to add the energy change induced by Nose/Hoover thermostatting +and barostatting to the system's potential energy as part of +"thermodynamic output"_thermo_style.html. + +These fixes compute a global scalar and a global vector of quantities, +which can be accessed by various "output +commands"_Section_howto.html#howto_15. The scalar value calculated by +these fixes is "extensive"; the vector values are "intensive". + +The scalar is the cumulative energy change due to the fix. + +The vector stores internal Nose/Hoover thermostat and barostat +variables. The number and meaning of the vector values depends on +which fix is used and the settings for keywords {tchain} and {pchain}, +which specify the number of Nose/Hoover chains for the thermostat and +barostat. If no thermostatting is done, then {tchain} is 0. If no +barostatting is done, then {pchain} is 0. In the following list, +"ndof" is 0, 1, 3, or 6, and is the number of degrees of freedom in +the barostat. Its value is 0 if no barostat is used, else its value +is 6 if any off-diagonal stress tensor component is barostatted, else +its value is 1 if {couple xyz} is used or {couple xy} for a 2d +simulation, otherwise its value is 3. + +The order of values in the global vector and their meaning is as +follows. The notation means there are tchain values for eta, followed +by tchain for eta_dot, followed by ndof for omega, etc: + +eta\[tchain\] = particle thermostat displacements (unitless) +eta_dot\[tchain\] = particle thermostat velocities (1/time units) +omega\[ndof\] = barostat displacements (unitless) +omega_dot\[ndof\] = barostat velocities (1/time units) +etap\[pchain\] = barostat thermostat displacements (unitless) +etap_dot\[pchain\] = barostat thermostat velocities (1/time units) +PE_eta\[tchain\] = potential energy of each particle thermostat displacement (energy units) +KE_eta_dot\[tchain\] = kinetic energy of each particle thermostat velocity (energy units) +PE_omega\[ndof\] = potential energy of each barostat displacement (energy units) +KE_omega_dot\[ndof\] = kinetic energy of each barostat velocity (energy units) +PE_etap\[pchain\] = potential energy of each barostat thermostat displacement (energy units) +KE_etap_dot\[pchain\] = kinetic energy of each barostat thermostat velocity (energy units) +PE_strain\[1\] = scalar strain energy (energy units) :ul + +These fixes can ramp their external temperature and pressure over +multiple runs, using the {start} and {stop} keywords of the +"run"_run.html command. See the "run"_run.html command for details of +how to do this. + +These fixes are not invoked during "energy +minimization"_minimize.html. + +:line + +[Restrictions:] + +{X}, {y}, {z} cannot be barostatted if the associated dimension is not +periodic. {Xy}, {xz}, and {yz} can only be barostatted if the +simulation domain is triclinic and the 2nd dimension in the keyword +({y} dimension in {xy}) is periodic. {Z}, {xz}, and {yz}, cannot be +barostatted for 2D simulations. The "create_box"_create_box.html, +"read data"_read_data.html, and "read_restart"_read_restart.html +commands specify whether the simulation box is orthogonal or +non-orthogonal (triclinic) and explain the meaning of the xy,xz,yz +tilt factors. + +For the {temp} keyword, the final Tstop cannot be 0.0 since it would +make the external T = 0.0 at some timestep during the simulation which +is not allowed in the Nose/Hoover formulation. + +The {scaleyz yes} and {scalexz yes} keyword/value pairs can not be used +for 2D simulations. {scaleyz yes}, {scalexz yes}, and {scalexy yes} options +can only be used if the 2nd dimension in the keyword is periodic, +and if the tilt factor is not coupled to the barostat via keywords +{tri}, {yz}, {xz}, and {xy}. + +These fixes can be used with dynamic groups as defined by the +"group"_group.html command. Likewise they can be used with groups to +which atoms are added or deleted over time, e.g. a deposition +simulation. However, the conservation properties of the thermostat +and barostat are defined for systems with a static set of atoms. You +may observe odd behavior if the atoms in a group vary dramatically +over time or the atom count becomes very small. + +[Related commands:] + +"fix nve"_fix_nve.html, "fix_modify"_fix_modify.html, +"run_style"_run_style.html + +[Default:] + +The keyword defaults are tchain = 3, pchain = 3, mtk = yes, tloop = +ploop = 1, nreset = 0, drag = 0.0, dilate = all, couple = none, +scaleyz = scalexz = scalexy = yes if periodic in 2nd dimension and +not coupled to barostat, otherwise no. + +:line + +:link(nh-Martyna) +[(Martyna)] Martyna, Tobias and Klein, J Chem Phys, 101, 4177 (1994). + +:link(nh-Parrinello) +[(Parrinello)] Parrinello and Rahman, J Appl Phys, 52, 7182 (1981). + +:link(nh-Tuckerman) +[(Tuckerman)] Tuckerman, Alejandre, Lopez-Rendon, Jochim, and +Martyna, J Phys A: Math Gen, 39, 5629 (2006). + +:link(nh-Shinoda) +[(Shinoda)] Shinoda, Shiga, and Mikami, Phys Rev B, 69, 134103 (2004). + +:link(nh-Dullweber) +[(Dullweber)] Dullweber, Leimkuhler and McLachlan, J Chem Phys, 107, +5840 (1997). diff --git a/examples/USER/uef/README b/examples/USER/uef/README new file mode 100644 index 0000000000000000000000000000000000000000..aaf53fa2a115a38ec297f70e0db67b6503f2a180 --- /dev/null +++ b/examples/USER/uef/README @@ -0,0 +1,19 @@ +This directory contains two short example scripts for the USER-UEF +package. + + +nvt_uniaxial: + A simulation of a WCA fluid under constant volume uniaxial strain + with stretching in the z direction, compression in the x and y + directions.The xx, yy and zz components of the pressure tensor are + written to the log file. The simulation conditions are the same + used in the paper by Thomas Hunt [http://arxiv.org/abs/1310.3905] + and should yield an zz pressure near 5 and xx/yy pressures near 10. + +npt_biaxial: + A simulation of a WCA fluid under stress-controlled biaxial strain + with stretching in the x and y directions, compression in the z + direction. The zz stress is controlled using the ext keyword in fix + npt/uef. The xx yy and zz components of the pressure tensor are + written to the log file. The simulations conditions should yield + xx/yy pressures near 5 and zz pressure near 10 diff --git a/examples/USER/uef/npt_biaxial/data.wca b/examples/USER/uef/npt_biaxial/data.wca new file mode 100644 index 0000000000000000000000000000000000000000..889ba4d2f2a8d2cb3892bda144544f23140ccc03 --- /dev/null +++ b/examples/USER/uef/npt_biaxial/data.wca @@ -0,0 +1,1022 @@ +LAMMPS data file via write_data, version 14 May 2016, timestep = 400000 + +500 atoms +1 atom types + +0.0000000000000000e+00 8.3979809569125372e+00 xlo xhi +0.0000000000000000e+00 8.3979809569125372e+00 ylo yhi +0.0000000000000000e+00 8.3979809569125372e+00 zlo zhi + +Masses + +1 1 + +Pair Coeffs # lj/cut + +1 1 1 + +Atoms # atomic + +7 1 2.4137737201272674e-01 2.0017433398687118e-01 3.6157393311703534e-02 2 1 2 +398 1 1.6739594898193126e+00 3.0313452824803544e-01 5.7986723161362197e-01 -3 0 1 +173 1 6.1370793327804556e+00 4.4978954867119525e-01 3.6568951377817088e-01 -4 1 0 +462 1 7.8754716784931862e+00 5.2908038473333074e-01 7.9185633743762940e-01 1 1 -2 +383 1 6.5373096080170212e-01 1.5337525983981986e+00 6.3208419126059423e-01 2 0 1 +288 1 1.9354124990672374e+00 1.3318105136786291e+00 3.6211635210084403e-01 -1 1 0 +303 1 2.9661308460819318e+00 1.1444058564802859e+00 6.5604777151148241e-01 -2 2 1 +491 1 7.1514675802966758e+00 1.3588685826107376e+00 1.2875068928885325e-01 -1 0 0 +187 1 3.0670386025081497e-01 2.4850915964494620e+00 7.0944157374329464e-02 0 -1 0 +163 1 1.2805212773629451e+00 2.4034621328433090e+00 2.0184086197146742e-01 0 1 -1 +345 1 2.5952244948945173e+00 2.3405536448220743e+00 3.0019149048630317e-01 -3 2 1 +447 1 3.9059163101716741e+00 1.6849179478858272e+00 6.0306488750926446e-01 -2 3 -4 +108 1 4.9215629854759335e+00 2.5174843149522088e+00 6.2779912940916158e-02 1 0 -1 +427 1 6.3978861821382305e+00 1.9201774263431104e+00 4.3981049730412797e-01 -1 -2 -3 +96 1 7.4061541304605534e+00 2.4828308207907996e+00 2.4705543772216432e-01 0 -3 2 +494 1 8.0759482343563711e+00 1.6914241739458744e+00 6.8482420189075921e-01 -3 1 2 +360 1 3.1886448226656765e+00 3.1126224743956139e+00 5.4052217066940123e-01 1 1 -2 +179 1 4.2399500260508116e+00 2.8640916432630559e+00 7.5278462735962870e-01 -1 1 1 +136 1 6.2603021059339365e+00 3.2638426060411403e+00 9.9163685662983045e-02 -2 0 3 +311 1 8.0699058291845773e+00 3.1228722160017734e+00 7.5458759573094458e-01 -3 -3 3 +242 1 8.1363443818268044e-02 3.8061968817045986e+00 5.4644298839992535e-02 1 1 1 +451 1 1.9291602479953753e+00 3.5896469823727863e+00 2.3008537852985023e-01 -1 0 0 +118 1 5.3566912079946780e+00 3.5234509548370374e+00 6.7801317822012042e-01 1 -3 -1 +200 1 6.7588369512940338e-01 6.1719413314115790e-01 9.9275606042642373e-01 -1 2 3 +23 1 2.1873327028525060e+00 4.2754803645009956e-02 1.4143560341384132e+00 -3 -1 0 +30 1 3.9592898204338112e+00 6.8093268022015185e-01 1.2987004742604558e+00 -1 -2 -2 +26 1 5.1175076813830467e+00 5.1869033157649591e-01 9.5797839381311178e-01 0 1 2 +452 1 6.5582763761917411e+00 3.4514602671261341e-01 1.2368598815410630e+00 -2 0 -2 +439 1 8.3865135868155445e+00 1.4825845267600596e-01 1.6737363681796917e+00 -2 3 1 +492 1 1.6645816560197648e+00 9.7557398318995125e-01 1.3973497820249918e+00 -2 3 1 +287 1 2.8845951500519784e+00 9.2974386224238703e-01 1.6104516406361071e+00 2 -1 2 +87 1 5.9282888423658395e+00 1.2716232081523247e+00 1.1744299163086194e+00 -1 2 -1 +191 1 7.0465887128985001e+00 1.3447129135151838e+00 1.1378718594147066e+00 -1 2 0 +316 1 6.6785856436835267e-01 2.4243200282222617e+00 1.1253836626025919e+00 0 1 0 +176 1 1.8165460632802826e+00 2.1437252128100086e+00 1.0868234266569741e+00 1 1 1 +244 1 3.5041229236927576e+00 2.3924032537771125e+00 1.3551249499971583e+00 -3 1 4 +463 1 4.9238071200835165e+00 1.7488964460038467e+00 8.7393010597649756e-01 -2 2 1 +101 1 4.7502017837518187e+00 2.5070270251466997e+00 1.6042073679153410e+00 -3 0 -2 +456 1 6.7262574842655534e+00 2.1937608587635533e+00 1.5819520420856528e+00 0 2 3 +90 1 7.8106680805872131e+00 2.3465270292028992e+00 1.4066520475037838e+00 0 -4 1 +457 1 2.2543678933961773e+00 3.1652213402916889e+00 1.1451988834668292e+00 -1 0 0 +344 1 5.9751963550424136e+00 2.8740523385222234e+00 1.2530570351392452e+00 0 1 -1 +399 1 8.2525481582297566e-01 3.4796551803028120e+00 1.0452539946382762e+00 1 -1 -1 +472 1 2.5500022667255768e+00 4.1144011701979659e+00 1.1937493716055980e+00 0 1 2 +364 1 3.2074279852156709e+00 3.3909867375667604e+00 1.5492265188845586e+00 -1 0 0 +333 1 4.2063776055408209e+00 3.7436012461483292e+00 1.2983951160694676e+00 -1 1 1 +223 1 6.0720407506223024e+00 3.9437056464141231e+00 1.5634726007362729e+00 0 0 1 +277 1 6.8850289844945918e+00 3.5744109988378070e+00 1.1843729982426427e+00 2 0 0 +487 1 8.0236797280148657e+00 4.0759691449476652e+00 1.1816920447826709e+00 -1 0 5 +202 1 1.1425010515906946e+00 1.1629395296284512e-02 2.5086432758529211e+00 -1 -2 0 +139 1 2.3147555111337756e+00 1.8665688332261610e-01 2.4220734387693037e+00 -5 0 1 +218 1 3.5367098631556342e+00 6.2760250051756761e-01 2.4478818232869410e+00 1 0 -2 +10 1 4.3729774450168737e+00 1.6632191047636544e-01 2.1079853667170236e+00 -2 -1 -2 +64 1 5.7303792911825742e+00 2.9006680684615282e-01 1.9605629224377070e+00 -2 1 2 +40 1 6.5824557178778531e-01 8.5028950299011019e-01 2.1496168105059708e+00 2 1 1 +328 1 1.5589817713112594e-01 1.6225523918451032e+00 1.7310231111691350e+00 3 0 0 +292 1 2.1314993621742819e+00 1.2260233186264009e+00 2.3652294967955245e+00 0 0 -1 +245 1 4.6666032401598603e+00 1.5042368206958292e+00 1.9142905720694421e+00 -3 1 -1 +148 1 6.7720428171922631e+00 8.7008110148972428e-01 2.0934267451930806e+00 0 0 1 +435 1 7.7341388550057273e+00 9.1983544373491155e-01 1.8223856537522831e+00 -2 -1 1 +301 1 2.9295611364078922e-01 2.4942786265027763e+00 2.2355337509297120e+00 -2 -3 -2 +476 1 1.3648021789963285e+00 1.8605609454926342e+00 2.0851101905225424e+00 1 0 -1 +310 1 2.6428836469132526e+00 2.1636738846129742e+00 1.7827293416008847e+00 3 2 0 +137 1 3.6368685754799719e+00 1.7198335009724290e+00 2.1014306554853008e+00 1 -1 1 +434 1 5.6400362255303138e+00 2.0264029757942144e+00 1.7648993119896872e+00 0 -1 0 +184 1 7.6228520959849160e+00 2.1704001606029473e+00 2.4690779972373509e+00 0 1 -1 +5 1 1.5547914352159820e+00 3.0246432147284117e+00 1.9341058666944422e+00 5 1 -2 +41 1 3.5394530649909939e+00 2.8672493763709368e+00 2.3721754433370239e+00 0 0 0 +410 1 5.2622202291807252e+00 3.3532222678989076e+00 2.0249715425869179e+00 2 1 1 +418 1 6.2986243250817040e+00 2.9042203242504363e+00 2.3450580832445986e+00 -1 2 0 +34 1 6.5845359986575269e-01 3.5330771386953552e+00 2.1708302646106170e+00 -2 3 1 +67 1 2.2321109286615104e+00 3.8391986294826608e+00 2.3598318070524229e+00 1 -1 0 +390 1 4.4001972293445766e+00 3.7784400898230768e+00 2.3530190506208175e+00 1 2 -1 +125 1 6.8584035481270371e+00 3.7859398002695177e+00 2.2262509649550242e+00 -3 1 3 +105 1 8.0142836210079444e+00 3.4253500628703644e+00 1.9822510084209746e+00 1 0 -2 +274 1 4.5713678557713822e-01 5.4244335571632307e-01 3.0849174937154351e+00 1 -2 1 +314 1 1.8447059547300777e+00 1.1692544876557610e-01 3.3199499683474132e+00 2 0 -1 +408 1 3.1814603728989130e+00 7.4387930556111925e-02 3.3119410401147560e+00 -1 1 1 +142 1 5.0629800765951494e+00 4.5529434814892644e-01 2.8994044435235393e+00 2 -1 -3 +25 1 6.1307890615815195e+00 4.8707110399724851e-01 2.9156227033318936e+00 0 2 -4 +458 1 7.5149810474983081e+00 4.9072663758191898e-01 2.7754564040841219e+00 2 -4 0 +165 1 1.3117326379233891e+00 1.1343392736952256e+00 3.1076574691841947e+00 -2 2 2 +421 1 2.7633861789985827e+00 9.5478806243591052e-01 3.1957876340691875e+00 -1 -3 1 +151 1 4.7220243778881930e+00 1.4282004346636548e+00 3.2642378377455432e+00 0 0 -1 +162 1 5.6468847674841811e+00 1.3364063405496600e+00 2.5903751818453160e+00 4 -4 -2 +120 1 8.2129099591176686e+00 1.3575499019485984e+00 2.6634845511723606e+00 0 0 0 +448 1 8.8805142887530297e-01 2.2694079305496020e+00 3.1897834611367313e+00 -1 1 3 +50 1 2.9687835700409062e+00 1.9135157390691884e+00 2.8548074734572992e+00 -3 0 1 +443 1 4.0462687470728396e+00 2.3330394967344139e+00 3.1667340148022216e+00 0 1 -2 +482 1 4.9427462157614270e+00 2.1611442624383619e+00 2.6370759110090005e+00 0 3 3 +407 1 5.7753726348779013e+00 2.4435329312939671e+00 3.1756094964019836e+00 0 1 -1 +100 1 6.6610073695947598e+00 1.9476592422501362e+00 2.6046914024931409e+00 -2 -2 1 +99 1 3.5098260053604374e-01 3.2489377905726768e+00 3.1253385231740438e+00 -1 1 -1 +107 1 1.3942178307183000e+00 3.1914627339242005e+00 2.9813408440396350e+00 2 0 1 +480 1 2.3066257454835091e+00 2.6794898513136354e+00 2.7495660819550110e+00 -1 -2 -1 +115 1 3.1214377398204638e+00 2.9223083977660864e+00 3.3233156913824242e+00 1 2 1 +278 1 5.0520729931158854e+00 3.1424127338010743e+00 3.1175324674801042e+00 0 0 -1 +206 1 7.7081484276756580e+00 3.0580419350207482e+00 3.0362913717240096e+00 0 -1 -4 +4 1 1.3000434256419220e+00 4.1733384323360649e+00 2.6659576195319934e+00 1 0 2 +214 1 3.2669228431804429e+00 3.8002115979716740e+00 2.6408106015701289e+00 0 0 0 +65 1 4.0280349657536760e+00 3.3861374196314542e+00 3.2331032594455227e+00 2 1 2 +490 1 5.8571557116011554e+00 3.8735942685941813e+00 2.8613897619661586e+00 -1 -2 0 +230 1 2.4828380364158602e+00 5.5335473677805791e-01 4.1950137944148906e+00 2 -1 3 +234 1 4.2752320357614213e+00 1.4212800762204394e-01 3.7635975156407624e+00 -2 1 -4 +92 1 5.6957646578006917e+00 2.5374658514218495e-02 3.8304068113906884e+00 0 -1 0 +103 1 7.0230616578295741e+00 4.6755655210711161e-01 3.8662999072020967e+00 1 -2 1 +129 1 8.1671299320274162e+00 5.7067862198193264e-01 4.0702212708530077e+00 -1 -2 0 +483 1 3.2862260723228903e-01 1.4557716141563948e+00 3.6577409481728278e+00 -3 4 -1 +110 1 1.5047240722693447e+00 1.0396158231062973e+00 4.0843832165787424e+00 -2 -1 0 +126 1 3.7388270640303456e+00 1.1962750537841655e+00 3.4335639532998909e+00 3 0 0 +276 1 5.6087889039130960e+00 1.1358153696317190e+00 3.7428282467743927e+00 0 2 1 +294 1 6.5127919732673050e+00 1.4345197299837358e+00 3.4448769173070444e+00 -2 0 2 +417 1 7.5734653423068021e+00 1.3756634588591667e+00 3.5078056411981438e+00 -1 1 0 +102 1 1.1107713360470239e+00 2.0167473232388695e+00 4.1576658165713738e+00 -2 0 0 +228 1 2.0072330566273600e+00 1.8105875233272237e+00 3.4619908126078429e+00 2 0 -1 +2 1 3.2101113937010530e+00 2.0183489554560774e+00 3.8822820800419566e+00 0 1 -1 +222 1 4.2730523271288350e+00 1.9092752363315002e+00 4.1553216684001049e+00 1 -1 0 +332 1 6.5042309397343736e+00 2.2214607151080448e+00 4.1057034120156182e+00 0 1 3 +275 1 7.5099659540449100e+00 2.2790896507455778e+00 4.1566328430638730e+00 -1 0 -1 +243 1 8.2736142057938107e+00 2.3393256795577462e+00 3.4990413844829384e+00 0 0 -2 +394 1 5.8512440497757878e-01 2.8807282965119669e+00 3.9612614891397042e+00 1 3 1 +325 1 2.1875714466797338e+00 2.8726101452768167e+00 3.8147636089102748e+00 0 2 -1 +468 1 5.6059790271973755e+00 2.9975764588671621e+00 3.9816014902843078e+00 0 1 0 +113 1 6.5849924400139104e+00 3.1808065990344776e+00 3.4367361163256929e+00 0 0 1 +47 1 1.0081753047752569e+00 3.9556172416934308e+00 3.8502376136806813e+00 1 -1 0 +474 1 1.9694475511677239e+00 3.9381337754040748e+00 3.4201230948176762e+00 4 1 -1 +343 1 3.0370114219017328e+00 3.9465351732349148e+00 3.7436387890882474e+00 0 -2 3 +257 1 6.0639634839200358e+00 3.9545122043987475e+00 3.7922755780058259e+00 1 3 -3 +422 1 7.3939236737263112e+00 3.9358351587357783e+00 3.4932390476416106e+00 -2 -1 -3 +317 1 3.5159353631335000e+00 5.3479576975233323e-01 4.4869163379906354e+00 -1 -2 -4 +322 1 5.5733359556605757e+00 4.8698103039818835e-01 4.7704783768556309e+00 1 6 -1 +453 1 7.3567123647601029e+00 8.3432787155128474e-02 4.8780449077720851e+00 -2 3 2 +82 1 5.8224871123849942e-01 1.1896491837492689e+00 4.7267276175254507e+00 3 0 -1 +402 1 2.4848673528490579e+00 1.6438582837634208e+00 4.4663750233867230e+00 0 2 3 +201 1 3.5370299676438193e+00 1.4874347892452509e+00 4.7752714735806165e+00 0 -2 -1 +159 1 4.7745775925936407e+00 9.0511891230699659e-01 4.2787903105333260e+00 0 -2 2 +239 1 6.3670232447984816e+00 1.2120460051587267e+00 4.4601763672019308e+00 0 1 -1 +340 1 7.6240687426290750e+00 1.3432987598476136e+00 4.6741720105351368e+00 -2 1 1 +246 1 6.4819140516389595e-02 2.1918155429312383e+00 4.6033031341679633e+00 0 2 1 +268 1 5.2454607296226170e+00 2.0016193334579642e+00 4.2366338410742728e+00 -2 2 0 +238 1 1.7670560071066166e+00 3.0774892421151585e+00 4.7759677543328642e+00 0 0 0 +183 1 2.7500175098986750e+00 2.8066272725663279e+00 4.6976729622871014e+00 -2 0 0 +393 1 3.6570205199594930e+00 3.1994600133365143e+00 4.2220986255821451e+00 1 2 -1 +177 1 4.6077861627416805e+00 2.8922144055644265e+00 4.5492372075807843e+00 0 -1 0 +97 1 2.5306051464072796e+00 3.9363146816844674e+00 4.9489842130852137e+00 2 0 1 +16 1 5.1924745493168265e+00 3.7357318418579575e+00 4.8717896643693246e+00 0 -2 -1 +15 1 6.1086100243278070e+00 4.1952083415168335e+00 4.9407045230806066e+00 -1 0 -4 +467 1 6.6872865628091098e+00 3.3657369472951393e+00 4.6943068780100674e+00 1 2 2 +404 1 8.0052336596808171e+00 3.5358005023997046e+00 4.5274309747477952e+00 2 2 -1 +190 1 9.4380374464947103e-01 4.4583992222855645e-01 5.4653306453144710e+00 1 0 1 +429 1 1.8525920421435695e+00 3.5762708549602490e-01 5.0946475568663319e+00 3 0 2 +356 1 3.9097878727975877e+00 6.1716052733039095e-01 5.4734744838905147e+00 -3 1 -1 +459 1 5.0297951477539122e+00 6.4682655744305417e-01 5.6718176557063691e+00 0 1 1 +140 1 6.3845220800541655e+00 6.6200714540119532e-01 5.4418985717149972e+00 2 -1 -2 +121 1 6.3608122327251349e-01 1.6422337064097718e+00 5.7379184381145940e+00 -2 -1 -1 +76 1 2.6863089369401427e+00 9.2826845731889596e-01 5.1620994403726908e+00 -1 -1 -1 +24 1 4.4731219011860990e+00 1.5605471103773427e+00 5.2523372789875760e+00 0 -1 -1 +215 1 5.5638567276602870e+00 1.5540980050800413e+00 5.2788517723209116e+00 2 1 0 +406 1 7.1965017439495353e+00 1.2927814031197866e+00 5.6667263284723859e+00 0 2 -2 +495 1 8.1400977173034548e+00 9.1998286287268760e-01 5.5427200454151757e+00 6 1 0 +256 1 1.5858394354874155e+00 1.8927406862702940e+00 5.2157829401895270e+00 4 0 1 +348 1 2.8144079358075680e+00 2.0457885486401644e+00 5.4765038200952452e+00 1 -1 2 +18 1 3.7959072614405218e+00 2.4151932066273840e+00 5.1090004037855792e+00 0 -2 -3 +259 1 4.8058181463022738e+00 2.5068639859502841e+00 5.5173228168937900e+00 0 0 1 +261 1 5.9067727879570278e+00 2.4818772803689844e+00 5.0470051254431221e+00 0 0 -3 +433 1 6.6238775496086628e+00 2.4655070126810084e+00 5.8390299036823690e+00 -4 1 0 +119 1 7.4961811313748150e+00 2.2560858298720374e+00 5.2761246161627531e+00 0 -2 0 +181 1 8.7803165796510541e-01 2.5368621724963174e+00 5.1009676967579534e+00 3 -4 -2 +392 1 1.3563447389359846e+00 3.2004762283973394e+00 5.8237816659365569e+00 0 1 -1 +436 1 2.3946011665804514e+00 3.0278168308484168e+00 5.6997814720410966e+00 1 1 2 +210 1 5.9632298308600022e+00 3.3253508577291475e+00 5.7908436280268685e+00 0 -1 -2 +409 1 8.2954742717592467e+00 2.8784369153928258e+00 5.3508660402584347e+00 0 0 0 +437 1 7.8285811502936531e-01 3.5972247646914322e+00 5.1173576054548029e+00 -1 2 1 +114 1 3.5350435499222215e+00 3.3621891050940294e+00 5.4926280066777995e+00 0 -1 1 +431 1 7.2810459589983303e+00 4.1806346853520422e+00 5.1699487852752508e+00 0 -1 2 +296 1 2.7493301442805773e-01 9.8739001637521445e-02 6.5256735912844297e+00 2 0 -1 +477 1 2.7650505314326872e+00 5.9323041848923519e-01 6.1880566096904213e+00 -1 0 -2 +199 1 3.8449072993955937e+00 6.8021783868606100e-01 6.5252139926754094e+00 1 0 -1 +31 1 6.8196091485194961e+00 6.5962784856610523e-01 6.6694400071986637e+00 0 -2 -1 +149 1 7.6325509159351759e+00 1.3582393886225264e-01 5.8995743775761014e+00 0 1 -2 +216 1 9.7752025904362638e-01 1.4078822836813889e+00 6.6728311339234487e+00 2 0 1 +425 1 1.7005586383875275e+00 1.1280428057946255e+00 5.8993957526091192e+00 -2 5 2 +224 1 2.8675797989920913e+00 1.6348520503423174e+00 6.4743030869420952e+00 1 0 0 +352 1 3.7461129077349202e+00 1.6467836683144792e+00 5.9711819974315681e+00 0 2 1 +289 1 5.0071286046398447e+00 1.3773263732616476e+00 6.4710057868740503e+00 2 -1 2 +455 1 6.2266605172975309e+00 1.4566180649712972e+00 6.2025029141131824e+00 0 1 2 +298 1 7.2166245583854813e+00 1.5995071342823830e+00 6.6916596114412981e+00 -2 2 -2 +42 1 8.3616236989495309e+00 1.1193553859054726e+00 6.6834990220304640e+00 1 -1 -1 +80 1 1.7994758316879240e+00 2.0602535563487749e+00 6.2756102858385763e+00 1 -1 -2 +127 1 4.3098326176630284e+00 2.3959981453352577e+00 6.4129162374884245e+00 -3 2 -4 +232 1 5.4258898148163945e+00 2.3715461809208245e+00 6.2879862147301759e+00 1 1 -4 +368 1 8.2199446060636472e+00 2.1052670796140989e+00 6.3974575157449376e+00 -1 -1 -2 +486 1 6.9787179588597281e-01 2.5321347977480562e+00 6.5634477651369929e+00 1 -2 1 +209 1 1.7697882729109665e-01 3.3153947644324067e+00 6.2408024968147000e+00 -1 0 -2 +152 1 3.1591516689848946e+00 2.6297173021869003e+00 6.2970081587154914e+00 -1 3 2 +353 1 3.7775468094107074e+00 3.3545010039524996e+00 6.5652719772105916e+00 0 -2 1 +361 1 7.1568303860427589e+00 3.3402954049017803e+00 6.0487812936573579e+00 1 1 0 +391 1 1.8477885811255761e+00 3.9829271272845177e+00 6.5960694610186286e+00 2 0 -1 +464 1 2.8125899145281190e+00 3.9218837233739201e+00 6.1411786897515759e+00 -2 2 1 +497 1 4.5524588331963729e+00 3.4967999912980696e+00 5.9321819433594642e+00 1 -2 2 +498 1 2.0830532473234906e+00 1.1220036849985102e-01 7.1674325217309276e+00 3 3 -1 +264 1 3.1008573853993013e+00 7.6076625369238260e-01 7.2316131354301971e+00 1 1 2 +265 1 4.6342157774659736e+00 7.4471207241976944e-01 7.1556952519725225e+00 0 -1 1 +350 1 5.7838647346068255e+00 5.9645078928256690e-01 6.9763870948006925e+00 2 -2 0 +144 1 1.9122165150526358e+00 1.1329756208528616e+00 6.9185463020768152e+00 0 1 1 +17 1 3.7256587791934250e+00 1.6333740129131904e+00 7.1341698423474043e+00 0 0 0 +441 1 3.6115685474483350e-01 1.9101453221098965e+00 7.5303824824165133e+00 0 1 2 +266 1 1.4762191689510862e+00 2.4662450761248356e+00 7.5398542897976331e+00 -3 -2 -2 +375 1 2.3309589830172550e+00 2.0436669163885055e+00 7.1892097709618481e+00 0 1 0 +351 1 4.7143585284219309e+00 1.8434829864646978e+00 7.2780594229535307e+00 1 0 1 +254 1 5.9170265466448875e+00 1.9140788620193201e+00 7.1554204752492074e+00 0 1 0 +29 1 1.5191420610560982e-01 2.9876711650320327e+00 7.5404622831951533e+00 1 -2 0 +198 1 1.9302038195524280e+00 2.9894398797282253e+00 6.7310853131736357e+00 2 -1 -2 +197 1 3.3083005500744571e+00 2.6144599213348498e+00 7.4059907643060248e+00 1 0 2 +192 1 4.3810729888763209e+00 2.8557380429470860e+00 7.4007735378272006e+00 1 0 1 +220 1 5.1223945377780948e+00 3.3376038243952149e+00 6.7920010375935584e+00 0 0 1 +432 1 6.2458841824934863e+00 2.9482647398415351e+00 6.8353911959966540e+00 0 2 -1 +20 1 7.5153792083913968e+00 2.5459516140888447e+00 6.9548679851000408e+00 3 -1 -2 +63 1 1.0659006163620912e+00 3.4796280956085210e+00 7.1592343773906313e+00 0 1 -2 +446 1 7.1139268453604680e+00 4.0629892995134789e+00 7.0800362551664415e+00 1 -3 -2 +172 1 8.3244437231535144e+00 4.0795393733923691e+00 7.1857426258997332e+00 2 0 -1 +405 1 2.0158180111850474e-01 7.3000938410316307e-01 7.6191994505829879e+00 0 -3 0 +323 1 1.4017230037752237e+00 4.6050949606146502e-01 7.9006469000953414e+00 2 1 -1 +428 1 2.4287753885012338e+00 4.6438480937363963e-01 8.3560508824421493e+00 3 0 2 +280 1 3.6502596381287908e+00 7.8205464112991063e-01 8.2256571665042131e+00 3 1 -1 +54 1 5.2270258856938900e+00 5.3851997974995880e-01 8.1047016704593808e+00 -1 0 -5 +397 1 7.4044521194737944e+00 1.4880482327788007e-02 8.2278445496777337e+00 1 0 2 +279 1 1.2356833818326960e+00 1.5625251472088779e+00 7.9109615213928013e+00 0 4 -2 +134 1 2.5628613498785486e+00 1.5781156241932268e+00 7.9994516338459301e+00 0 1 -1 +236 1 4.5573192582583912e+00 1.4401963680745278e+00 8.1580516205465621e+00 0 3 -3 +493 1 6.1321864263285528e+00 9.9745261592364498e-01 7.9044637123188437e+00 0 3 -3 +346 1 7.4631508711766701e+00 8.7980227698742530e-01 7.6161632460447608e+00 2 -1 -1 +295 1 3.6674081936683844e+00 2.3602153939048316e+00 8.3119852957626765e+00 0 1 -2 +164 1 5.5460188609614756e+00 1.8259166833804881e+00 8.1712445391317772e+00 -2 -2 -1 +354 1 6.6872220974400829e+00 2.0300640265600358e+00 7.8561422683464270e+00 1 2 0 +449 1 7.9034553200360103e+00 1.8534144914629234e+00 8.0299472682703943e+00 -1 -3 0 +185 1 9.5448193278219684e-01 3.3578879558028460e+00 8.1917731250955708e+00 1 1 -1 +229 1 2.5099351180061946e+00 3.0097254013180406e+00 7.8296711975898541e+00 -2 2 -1 +135 1 5.5895093348111047e+00 2.7786209311728598e+00 7.5930433616327404e+00 -1 0 -2 +211 1 7.0529928021063730e+00 3.1919477500830000e+00 7.6370125321552074e+00 -2 2 1 +81 1 1.8872269150105381e+00 3.9351057043865243e+00 7.6163648141042426e+00 0 -1 1 +37 1 3.6614705509244851e+00 3.4915765263742262e+00 7.7267865376074960e+00 2 0 1 +355 1 4.5831332879360058e+00 3.8667909487066860e+00 8.3349240075214972e+00 1 -2 0 +141 1 5.4975686789962985e+00 3.7534665361901731e+00 7.8536976598839008e+00 1 3 1 +122 1 7.2999342247943373e+00 3.9738648524411286e+00 8.3865006440763370e+00 0 -1 -2 +327 1 3.2503689184711210e-01 4.6592524224991747e+00 8.2659471361477532e-01 0 -2 2 +386 1 1.1858359917362140e+00 4.2742921253409367e+00 2.8183822072239956e-01 -1 -2 5 +59 1 1.8702404230468521e+00 4.9717730076471947e+00 7.6874981917086671e-01 0 2 -3 +57 1 2.8167286953460633e+00 4.2569068178507328e+00 1.1953882254793591e-01 1 -1 1 +489 1 3.6302378764516323e+00 4.4521177967574310e+00 6.6729235313037527e-01 1 1 5 +326 1 4.9856357064009993e+00 4.5330987087989216e+00 5.2454407858907726e-01 -1 2 2 +359 1 5.9913033298564331e+00 4.3362327743167306e+00 3.7835915829420080e-01 2 -1 -1 +349 1 7.2426723526689933e+00 4.7181533524380885e+00 7.2707643667494415e-01 0 1 -2 +247 1 8.6433343008963215e-01 5.6823007167579762e+00 6.5224250416194052e-01 1 -3 2 +365 1 3.8233209759419231e+00 5.6939269324333672e+00 5.9607489711922135e-01 -1 -1 0 +382 1 5.1137068164970731e+00 5.5805604939667059e+00 1.8276059551769425e-01 -1 -2 1 +130 1 8.2482820181805554e+00 5.5968590423898927e+00 4.4653409437071251e-01 -1 -1 2 +471 1 1.7119665678072469e+00 5.8953695416344436e+00 4.5930053740843135e-02 -2 0 1 +21 1 2.5641267140454049e+00 6.3080369711057624e+00 5.3936073769936865e-01 1 -2 0 +499 1 4.7164689695839286e+00 6.6465500795405017e+00 1.6611623106065540e-01 -1 -1 1 +253 1 5.9043290983731245e+00 6.1331552003521068e+00 7.5404520106110218e-01 3 -1 0 +302 1 6.9564884663410282e+00 6.1640675729464434e+00 5.7033134187391044e-01 0 -1 -1 +324 1 8.1992983060509594e+00 6.5972265856779417e+00 7.7494747996129210e-01 1 -3 2 +154 1 1.8996589089571863e+00 7.1193783454022102e+00 5.1404963792269565e-01 -3 -1 -1 +284 1 3.0007790559640597e+00 7.2198187648711993e+00 2.3642486802169203e-02 0 0 0 +161 1 3.8133207311484072e+00 7.3201299304675667e+00 5.0202507839899535e-01 -2 -4 -2 +112 1 5.6724794675417822e+00 7.1979165692397187e+00 7.3233205047939343e-01 -1 -3 -2 +39 1 6.4178033104766934e+00 6.8891409921259603e+00 1.5315709015991064e-01 0 0 2 +269 1 7.4906317471214443e+00 6.7375050108085421e+00 4.8287801879068511e-02 3 1 0 +470 1 2.2822847309207428e-01 7.8917014242385868e+00 7.7675485207454809e-01 0 0 1 +84 1 1.3672512040847244e+00 7.9379711016796204e+00 1.6230344562139010e-02 1 0 -3 +381 1 2.6740213254054948e+00 8.0161072175846630e+00 5.8246256296805565e-01 -1 -1 1 +416 1 3.6213693754100857e+00 8.3576521057616233e+00 6.2331560400527297e-01 2 2 -1 +182 1 5.1660049409085866e+00 8.0423641799361949e+00 3.0675573970032322e-01 -2 0 -1 +347 1 6.5429973279348026e+00 7.8912499362162034e+00 4.9818784876300565e-01 -1 1 -2 +380 1 7.4990421428201417e+00 7.6756533739549013e+00 7.5184655726615468e-01 -3 0 0 +19 1 1.4643514526638863e+00 4.2228380130315317e+00 1.3843336624933156e+00 0 3 -1 +430 1 4.3057981012626918e+00 5.0291601875436083e+00 1.2152759600723888e+00 1 1 -2 +212 1 5.0477378389079224e+00 4.2727344176247888e+00 1.5457805058503180e+00 -2 -1 2 +479 1 7.9063585867776194e+00 4.9679041912501303e+00 1.6188677256489217e+00 1 3 -1 +217 1 2.5218672599222897e-01 5.8414577361250837e+00 1.5087288813722908e+00 2 1 2 +147 1 1.1545026869668784e+00 5.3345315151941692e+00 1.5114087897016817e+00 1 2 -1 +13 1 2.8751716646412713e+00 5.2058560720828826e+00 1.0454367061984737e+00 -2 1 -1 +170 1 5.1473087472466297e+00 5.7979187654554183e+00 1.4646868436401976e+00 1 2 0 +204 1 6.2817592200581442e+00 5.1972845711964553e+00 8.9956483663207842e-01 -1 -1 -1 +306 1 8.3865328816009488e-01 6.6369969836196416e+00 9.5403861420405511e-01 1 -1 3 +414 1 1.6815920771923107e+00 6.1626367729687450e+00 1.1744973520180511e+00 0 2 0 +79 1 3.3223472300560521e+00 6.2059256452802716e+00 1.3962300133956274e+00 0 0 0 +116 1 7.6213827835593815e+00 5.9109006810695996e+00 1.2032264335528675e+00 -2 -1 3 +231 1 2.7502476364406934e+00 7.3933926752228123e+00 1.4247539952768773e+00 3 -1 1 +171 1 4.7071880050572981e+00 6.8064285791523735e+00 1.2807974821888473e+00 0 -2 1 +273 1 7.0329000376929018e+00 6.8584131720717227e+00 1.6693583798609657e+00 -2 1 -1 +260 1 8.0496857982994889e+00 7.4547112671714686e+00 1.6374112984134654e+00 3 -1 -2 +43 1 1.0723712760276345e+00 8.0330657119523838e+00 1.4245919245059160e+00 -2 1 0 +208 1 4.3910624755767662e+00 7.9590156044378260e+00 1.1638330407357564e+00 -2 -2 -1 +226 1 5.5077902922207063e+00 8.0548948337249193e+00 1.2764179622713128e+00 0 0 2 +370 1 6.4142184578798505e+00 7.6748965104033502e+00 1.5118878610721513e+00 1 1 1 +85 1 4.9493682223295465e-01 4.4925581352788218e+00 1.7962077237252332e+00 2 0 0 +213 1 2.1575495906041722e+00 4.9142597626853277e+00 1.8811900528366003e+00 0 3 0 +299 1 3.3659976969419567e+00 4.3662606017243588e+00 1.7255850309353928e+00 3 -1 -2 +249 1 4.7082373488231886e+00 4.9470082900514569e+00 2.3877787475724284e+00 0 0 1 +258 1 5.7775488222451887e+00 4.8696821219175135e+00 2.2927307255193869e+00 -1 0 -1 +388 1 6.8398302583746604e+00 4.7642336931962808e+00 1.8670074890749995e+00 1 -4 -3 +91 1 7.7108281252011066e+00 4.3462922152329373e+00 2.4115614404022634e+00 2 -2 1 +415 1 1.3354264256961873e-01 5.2683808667768846e+00 2.4940378524658144e+00 0 3 0 +27 1 2.0564207334277329e+00 5.6999752852325889e+00 2.4901436865643838e+00 0 -2 -1 +465 1 3.6077777180133985e+00 5.3106225786683270e+00 2.2984375934854913e+00 1 4 2 +72 1 1.2115862831734683e+00 6.3271145377400213e+00 2.3088380865765914e+00 -1 -2 -1 +58 1 2.4730215910430200e+00 6.4108021967014599e+00 1.8872921058165837e+00 2 -2 2 +88 1 4.2468496124355051e+00 6.0000736368680991e+00 1.9689248186008255e+00 1 0 -1 +6 1 5.2824888171486872e+00 6.1177755165021708e+00 2.4648490036232666e+00 0 -3 1 +75 1 6.5540148621238368e+00 5.8837981825070473e+00 1.8049347572360399e+00 -3 0 4 +22 1 7.8390642986715990e+00 6.6390504342942007e+00 2.2941937725662940e+00 0 1 0 +128 1 5.0900588055916374e-01 6.9175984002222233e+00 1.8531623061329514e+00 -1 0 1 +193 1 1.7616411201473283e+00 7.3777929885216569e+00 1.8819221158557660e+00 -2 0 0 +389 1 3.8054852300865960e+00 7.1908689074118346e+00 1.6897648139570383e+00 1 -1 -1 +241 1 3.3304867419800805e+00 6.7201719117843943e+00 2.3881392654044515e+00 0 1 0 +14 1 5.6091745306383807e+00 6.8869789388403264e+00 1.7385824045568810e+00 0 -1 0 +307 1 2.6028552221612093e+00 7.5983757451277896e+00 2.5134014261731092e+00 -1 1 0 +401 1 3.3924470446908370e+00 8.2185878004411617e+00 1.7224400376656741e+00 -3 -2 2 +248 1 4.8372436612670020e+00 7.6440956091999794e+00 2.0947200376368853e+00 2 -3 0 +335 1 7.0823280457514208e+00 7.5905134700352388e+00 2.4694687185743178e+00 -1 0 0 +281 1 7.4000691269637358e+00 8.3890728034516613e+00 1.8965880690997261e+00 -1 -1 0 +33 1 2.6215904333511340e+00 4.6944190932346643e+00 2.8031190571610427e+00 1 1 1 +221 1 3.7745777664099962e+00 4.5666560881588492e+00 3.0592511133135365e+00 0 -1 1 +251 1 6.7715334943605834e+00 4.6401458096684580e+00 2.8510683358464712e+00 1 -2 -2 +138 1 1.1922779528936784e+00 5.1973855619084013e+00 2.5689556972218521e+00 0 1 0 +73 1 4.3331751132449305e+00 5.7904710852531096e+00 2.9618985356431899e+00 0 -2 2 +237 1 6.2300560736724488e+00 5.7475979505901522e+00 2.7248929404434143e+00 3 0 0 +77 1 7.3913602469000059e+00 5.6780386160747609e+00 2.6234944353061729e+00 -1 -1 3 +339 1 2.9546703425028309e-01 6.2132195219954411e+00 2.7867557714215443e+00 0 0 2 +69 1 1.3562182919504069e+00 6.0134582221288868e+00 3.2785943115156346e+00 0 -2 1 +150 1 2.9668876558472732e+00 5.9472670316673391e+00 2.8936146954206632e+00 3 -2 -1 +219 1 1.1608118939764323e+00 7.3228681938207032e+00 2.7126116817865631e+00 0 -3 -1 +9 1 2.0627854045350777e+00 6.7454186793237145e+00 2.9360002216641958e+00 0 -2 -2 +3 1 2.9445094497077151e+00 7.1384526732484925e+00 3.3587771406211751e+00 2 -1 -2 +93 1 3.8294061315771235e+00 7.5378392781893275e+00 2.8380550678413003e+00 -1 2 0 +68 1 4.5306997862577427e+00 6.7390306077267583e+00 2.7235217150491495e+00 1 1 3 +35 1 5.4701910601523354e+00 6.9880160912814793e+00 3.3190052755169512e+00 0 0 -2 +174 1 6.2873908725084267e+00 6.7805871501360224e+00 2.7219816088319484e+00 -1 0 2 +369 1 1.7965435829527715e-01 8.0388194202620209e+00 2.5940286664394834e+00 -3 -2 1 +469 1 4.9516921171039039e+00 7.8826764349301754e+00 3.0530014528334970e+00 0 -2 -1 +270 1 5.8608285132223106e+00 7.6946678024150144e+00 2.6778659829007898e+00 0 -1 -2 +196 1 7.6768577919393455e-01 4.8792664640921366e+00 3.5903070116215088e+00 3 -1 1 +235 1 4.2285310787746502e+00 4.2638690385284841e+00 4.1560966227762339e+00 1 1 1 +104 1 4.9767847616154004e+00 4.2048445393860883e+00 3.3962447019771562e+00 -1 -2 4 +363 1 5.8883238331527643e+00 4.9482373301020921e+00 3.4294316309792547e+00 0 0 3 +440 1 8.3695482926311691e+00 4.2129368246316421e+00 3.4018022112738615e+00 -1 2 1 +271 1 1.8521235523587734e+00 5.0753345126075313e+00 3.3807703470063983e+00 0 2 1 +385 1 3.2904276665596646e+00 5.1796485809465160e+00 3.7980367644038786e+00 -3 -1 0 +367 1 4.4116421156217953e+00 5.2602223360914149e+00 3.9453911592241386e+00 1 1 0 +8 1 5.3112651984610038e+00 5.7540585999932050e+00 3.4831459566385630e+00 3 1 0 +445 1 6.8973470747727381e+00 5.7304789961834581e+00 3.7043310817118127e+00 -2 -1 2 +95 1 8.3390772303693836e+00 5.5440620917552232e+00 3.7707087770664116e+00 -2 1 -3 +227 1 2.6907357337748437e+00 5.9773212885609901e+00 3.9377639031978284e+00 -1 -2 0 +45 1 3.9484717591019058e+00 6.4426795460159951e+00 3.6915638730283460e+00 0 1 -1 +62 1 6.2921228111843934e+00 6.5338531152740655e+00 3.8634903896998787e+00 1 0 -3 +309 1 7.4708902093515182e+00 6.5908652825436720e+00 3.6007172393059794e+00 0 -2 0 +70 1 1.1631280783050528e-01 7.0230287218135894e+00 3.4578008409773004e+00 -1 -2 2 +285 1 1.4425208756199777e+00 7.4192404188139784e+00 3.7903676842933867e+00 0 1 -1 +387 1 2.1212416378368082e+00 6.7926691438538640e+00 4.1965603113934069e+00 1 -2 -1 +484 1 4.6356188966878253e+00 7.3783035166039177e+00 4.0565969174155132e+00 0 -1 -1 +98 1 6.8865210518165370e+00 7.3140090488700187e+00 4.1918733358514384e+00 0 -2 -2 +282 1 6.6401301602074470e-01 7.9757076330778913e+00 3.4568068256572881e+00 0 0 2 +203 1 2.5721741898113022e+00 7.9369081377447577e+00 4.0156309667060688e+00 0 3 0 +189 1 3.6912207664687133e+00 7.6806375475121094e+00 3.9059717431750585e+00 0 -1 0 +267 1 6.5713653654298607e+00 7.8128923355065503e+00 3.4078724648171090e+00 -3 -3 2 +155 1 7.9603563078893247e+00 8.1399268391964696e+00 3.4070072411074963e+00 -2 -3 -1 +313 1 1.7289301235151016e+00 4.3022360027322257e+00 4.5514630316827649e+00 0 1 -2 +250 1 3.3811553057719541e+00 4.4820133651244189e+00 4.8062617116575304e+00 1 1 1 +49 1 5.2294045670482578e+00 4.6507731504297771e+00 4.3588420415784839e+00 -1 2 -1 +111 1 6.9650608689197728e+00 4.6666276346705935e+00 4.3879356756979719e+00 1 1 -1 +124 1 8.0933085752880096e+00 4.6382186065764790e+00 4.3125441053619298e+00 1 1 -1 +488 1 5.0933114935797996e-01 5.1359886989747769e+00 4.5948583401263194e+00 -3 1 -2 +48 1 1.5851307073885004e+00 5.5767207395220701e+00 4.2311661806996650e+00 2 -2 1 +123 1 2.5153837170534041e+00 5.0458650845269890e+00 4.5131929409242613e+00 -1 -1 -1 +423 1 5.8208012531410862e+00 5.4948336589690365e+00 4.5916227902397422e+00 2 1 2 +329 1 7.4993364070942770e+00 5.4866100873090584e+00 4.5194723854672301e+00 -2 -2 -2 +334 1 7.1205767430238509e-01 6.1834005542640256e+00 4.2284519502384050e+00 0 1 -1 +146 1 1.3925739327604780e+00 6.6428737862846399e+00 4.8806888882719424e+00 0 1 -2 +500 1 2.2236367185474757e+00 6.0145074663436873e+00 4.9428276989368829e+00 0 1 1 +46 1 3.3290620592760245e+00 5.9295614805296450e+00 4.9789176350871935e+00 1 -1 -3 +374 1 4.7036984817853460e+00 6.2326093994181564e+00 4.3534332596232463e+00 -2 3 2 +52 1 6.8604388860085521e+00 6.3207993870641257e+00 4.9959828655023273e+00 0 -1 -1 +466 1 8.0663702260053096e+00 6.4797694103942982e+00 4.3885769098322607e+00 0 -1 -1 +272 1 6.3857634591010626e-01 7.4306626388140797e+00 4.4685908728843007e+00 -1 0 -1 +331 1 3.1923815943971330e+00 6.8406621847783482e+00 4.3673687027144910e+00 -1 -2 0 +12 1 5.5841339297795631e+00 7.2882403606371549e+00 4.4466343965097535e+00 4 3 0 +178 1 7.5912726284672463e+00 7.0457277620611389e+00 5.0302483408547527e+00 1 -2 0 +376 1 3.5187241629329796e-01 8.3977706803073371e+00 4.6278412560289910e+00 1 -5 2 +117 1 1.3379826357324891e+00 8.3239351364630743e+00 4.2945291322530599e+00 3 0 1 +419 1 1.8896223988418746e+00 7.6393579746671740e+00 4.8168734901107717e+00 0 1 2 +379 1 3.9801436864751545e+00 7.7556819889833708e+00 4.9922836416209275e+00 -1 -2 0 +53 1 4.7488025467298804e+00 8.2113497019933241e+00 4.7088252949914393e+00 -3 0 -1 +28 1 6.4645893658779787e+00 8.2802587137451660e+00 4.5908064174413035e+00 -1 0 -2 +300 1 8.0497419370896441e+00 7.6196002867575432e+00 4.2909429383935933e+00 0 3 0 +83 1 1.5533997706565803e+00 4.2394383012204173e+00 5.5726999917011435e+00 0 0 -1 +304 1 2.5788446900543724e+00 5.0166498820006939e+00 5.6119573167673691e+00 0 -1 0 +51 1 4.2443804124641717e+00 4.2352637746580450e+00 5.1927633388220640e+00 -2 -3 1 +180 1 8.3861058182094546e+00 4.2682396578102644e+00 5.2739914655295381e+00 2 -2 0 +60 1 1.6015559581031933e+00 5.1463292330916399e+00 5.1677022459932900e+00 3 -3 0 +255 1 3.9377408204864559e+00 5.5446289337866919e+00 5.6880007643189954e+00 -1 1 -1 +336 1 4.8593163697287496e+00 5.2245778091909907e+00 5.0488368666183758e+00 0 -1 0 +74 1 5.8562368106306470e+00 5.1343487602136690e+00 5.4844996621256241e+00 -1 -1 -1 +11 1 6.8757956599703460e+00 5.1962144116573894e+00 5.2833696751528123e+00 1 -1 1 +106 1 7.8813740148695439e+00 5.1326569274050362e+00 5.5073989898629776e+00 -2 0 1 +342 1 6.9861903942379322e-01 6.2397324279420259e+00 5.5554818983126264e+00 1 2 1 +366 1 1.5648860489287066e+00 5.8898927909510999e+00 5.8373116466465662e+00 -2 1 1 +153 1 2.7314006683241487e+00 6.0747252624615822e+00 5.8658792109688322e+00 2 0 0 +384 1 3.7649825100367740e+00 6.6140228235604797e+00 5.7068894568556274e+00 3 0 -1 +444 1 5.5919895424131791e+00 6.4007885907393334e+00 5.0609268438363237e+00 0 0 1 +169 1 8.1101285040334883e+00 6.0263607659074259e+00 5.3262646023669920e+00 2 -3 2 +312 1 1.5049751572049341e-01 7.0899457593186419e+00 5.3993285616214672e+00 -4 -1 2 +131 1 2.1405833530478784e+00 6.8932472731161107e+00 5.7016479425245992e+00 -1 -2 -5 +290 1 2.9965099079972810e+00 7.1703954961127128e+00 5.3705836189910157e+00 3 2 0 +240 1 4.7341951239220323e+00 7.1100411829110195e+00 5.1242936547927025e+00 -1 -4 5 +403 1 1.1346681749692125e+00 7.6627110490212882e+00 5.5800616996766177e+00 -3 2 3 +438 1 2.6845809734218404e+00 8.2016169024289791e+00 5.0687325841194584e+00 0 1 1 +420 1 4.5890023008209200e+00 8.1137042645946345e+00 5.6817522441295134e+00 -1 -3 -3 +175 1 5.5503185230040479e+00 7.9962207684468503e+00 5.3390442156703726e+00 -1 -2 1 +305 1 6.7862386693055941e+00 7.6108734242812508e+00 5.4748415197806564e+00 -1 0 0 +341 1 7.4912815420537060e-01 4.3291768420078673e+00 6.1635194432999105e+00 -3 0 0 +291 1 3.3895079643780628e+00 4.7034241504608403e+00 6.1615817441829774e+00 -1 0 1 +372 1 4.6184126650372983e+00 4.6292373343220516e+00 6.3125880555070495e+00 1 -1 -2 +293 1 5.5228203863122962e+00 4.2760181362826257e+00 5.8887719440294752e+00 2 2 2 +461 1 6.6292898049431850e+00 4.3535966489510214e+00 5.9130834363303126e+00 0 -1 -1 +263 1 7.7259268091094802e+00 4.4631499768470926e+00 6.3337285974251110e+00 -3 0 0 +473 1 5.8703225638324330e-01 5.3945075957215893e+00 6.1889975824903258e+00 1 -2 0 +166 1 1.6857123760309740e+00 5.0889285259544463e+00 6.6009674185523135e+00 2 2 2 +132 1 6.2122393744706681e+00 5.4126385838431412e+00 6.6911128610756689e+00 -1 2 1 +32 1 7.1447545314606753e+00 5.2817185569927805e+00 6.2574893275776935e+00 -1 1 0 +475 1 3.1727782520787395e-01 6.3991068893590928e+00 6.5410008153956287e+00 -1 2 0 +283 1 3.2886765713157047e+00 6.4577609617474216e+00 6.6450211825759427e+00 -2 5 -3 +205 1 4.9096514414971573e+00 6.2573093659948649e+00 5.9509143564095108e+00 1 1 0 +158 1 6.0709604726562620e+00 6.0618280221451721e+00 5.9241072976562341e+00 2 -3 1 +1 1 6.8533858129590133e+00 6.5562074315723597e+00 6.5648993855676077e+00 -2 -1 -2 +485 1 3.8125590702509465e-01 7.4616693598979804e+00 6.3609885403345947e+00 0 0 1 +378 1 1.3081995382782592e+00 6.9194359283210023e+00 6.2966360730695206e+00 -1 1 2 +71 1 4.2456384497919455e+00 6.8188407430282236e+00 6.6601493363974615e+00 -1 -4 -4 +320 1 5.9836892193800049e+00 7.1597807912498039e+00 5.9293654675383980e+00 -1 -1 -4 +481 1 7.6691355446374123e+00 7.2329848679784536e+00 6.1548343866270958e+00 2 0 -4 +318 1 1.3774303149915195e+00 8.3818831122591373e+00 6.3319633954681702e+00 -1 3 3 +496 1 2.5904412000483283e+00 7.6460489519926949e+00 6.2257027413180230e+00 0 1 0 +319 1 3.7413059213345305e+00 7.5724262762451815e+00 6.0123092822785358e+00 -2 0 0 +338 1 5.3628717868866635e+00 8.0629328638364353e+00 6.4489666989888104e+00 0 0 2 +358 1 6.2532288322758314e+00 8.3160028104100370e+00 6.1106737733333700e+00 1 1 3 +225 1 7.1188694406828850e+00 8.0966599202958953e+00 6.7037213079900431e+00 0 0 1 +55 1 1.0372861368831470e+00 4.4696141893250934e+00 7.4049774120079697e+00 -1 2 -1 +362 1 2.7501402171762614e+00 4.4083355662417896e+00 7.3996418874276850e+00 1 -1 0 +36 1 3.7396318187704796e+00 4.4801126663955504e+00 7.1074085083223073e+00 2 0 -2 +133 1 4.7860445539287522e+00 4.2902205437459102e+00 7.3711360387569274e+00 -1 -3 -2 +412 1 5.8687821857033606e+00 4.2035753083199188e+00 6.8227572622514323e+00 -4 3 0 +89 1 9.1212528791654535e-02 5.3554487915969240e+00 7.1088625783964092e+00 0 -2 0 +38 1 1.2571311964388701e+00 5.7525434192639207e+00 7.3210178579367868e+00 -1 -5 -2 +337 1 2.7511266822038212e+00 5.4161467707559394e+00 6.9980055112843935e+00 1 -2 -1 +233 1 3.8756258886529467e+00 5.7508116329978627e+00 7.0533607828281815e+00 0 0 -1 +442 1 4.9084237493694953e+00 5.5326539633780083e+00 6.7666717819135362e+00 -4 -4 1 +143 1 5.5776680237268401e+00 5.1621486864820874e+00 7.4635021710959082e+00 1 2 -2 +194 1 7.1453664245542576e+00 5.0984438205910134e+00 7.3333812213368574e+00 0 2 0 +308 1 7.5489760640996861e+00 5.8433222820659871e+00 6.9295207313931844e+00 0 0 0 +286 1 2.1326326019163346e+00 6.2556170719743678e+00 6.7379074391662934e+00 2 0 -2 +61 1 5.6654689088882648e+00 6.2935208603774795e+00 6.9534505775907345e+00 -2 1 -1 +426 1 7.2244687144599562e-01 7.0806885112202815e+00 7.2261712082790313e+00 -1 1 -2 +450 1 1.7213783340257280e+00 7.5184636193370302e+00 6.9767252413839369e+00 4 1 1 +188 1 2.8213470931093725e+00 7.2342621084044723e+00 7.1806231926796817e+00 0 -2 -1 +94 1 3.8026924767351562e+00 7.3932541518378949e+00 7.4596688811177305e+00 -1 2 -2 +252 1 5.1481924139065534e+00 7.2239227196376481e+00 7.0808756518162852e+00 -2 1 -1 +321 1 6.2155610611385042e+00 7.5199920009866501e+00 7.0964075868161212e+00 1 -1 -3 +156 1 7.9944514874782193e+00 7.0252703915440122e+00 7.2541499279788821e+00 -2 1 0 +167 1 5.6917482122629082e-01 8.1417190335213725e+00 7.4962901784513347e+00 2 -2 -1 +330 1 3.3138446283251373e+00 8.2146300363312132e+00 6.8886408760800295e+00 1 -2 0 +195 1 4.3712446295554876e+00 7.8995454090647614e+00 6.7366600234979277e+00 -3 -1 -1 +78 1 5.1856313345157918e+00 8.2127013524100576e+00 7.4620544007464273e+00 0 -1 1 +157 1 7.9011697675935482e+00 8.1764884669087454e+00 7.4266272279794077e+00 -1 0 -1 +373 1 6.7132530681439118e-01 5.0292807223694753e+00 8.1874843860841438e+00 1 2 -2 +56 1 1.7078519119356448e+00 4.9344764637762015e+00 8.1280520422148399e+00 0 2 0 +315 1 3.6234275175752244e+00 4.9451657793378052e+00 8.0476764469560074e+00 -1 -2 0 +478 1 6.4485922344872577e+00 4.3096951707056732e+00 7.7984645181472576e+00 -3 -1 1 +109 1 8.0579925616842267e+00 4.7034410927383776e+00 8.0870676538969590e+00 -1 -2 0 +357 1 2.6884169416542560e+00 5.4427652520296803e+00 8.2033924998655703e+00 0 3 1 +454 1 4.5709826050185614e+00 5.3780110248528246e+00 7.7764192595368709e+00 1 -1 2 +86 1 6.2280039286639228e+00 5.4780735688869227e+00 8.2809905303020894e+00 -1 1 0 +262 1 7.2349855745224341e+00 5.4460551342647063e+00 8.3066978094955939e+00 0 -2 2 +160 1 6.0572932237795518e-01 6.1031638741150802e+00 8.0606222325454144e+00 2 -1 1 +168 1 2.6926304594044645e+00 6.3106981827881823e+00 7.6217004925278191e+00 -1 -3 0 +145 1 3.6817206885980216e+00 6.4794531849637744e+00 8.1206460236595284e+00 -1 -1 -2 +400 1 4.6165015313151514e+00 6.4768264075412638e+00 7.5742703650137084e+00 1 -2 -2 +395 1 5.5951136272170219e+00 6.3298964082146654e+00 7.9312370644766386e+00 0 0 -1 +297 1 6.6597873155694378e+00 6.3692836044578955e+00 7.6364845321455510e+00 1 -4 0 +207 1 8.0115395128671594e+00 5.9375044868831406e+00 7.8466324008781454e+00 -1 1 3 +460 1 6.6754980612335257e-01 7.0521823363262239e+00 8.3451452216672077e+00 -2 1 -3 +44 1 1.5985553198249884e+00 6.8250382119954756e+00 7.7469635466673052e+00 0 1 0 +377 1 4.7397084186898368e+00 7.4631435688157008e+00 8.0338331164055763e+00 0 -1 0 +411 1 5.8132963527118724e+00 7.4646663474419555e+00 8.0261071780587709e+00 2 -1 1 +396 1 7.0242838781762282e+00 7.3479893628886632e+00 7.6603703429086574e+00 2 3 0 +424 1 8.1516255787718581e+00 7.5530513248894016e+00 8.2349155971796755e+00 -2 0 0 +66 1 2.2362583327280716e+00 7.7449451931440727e+00 7.8847519662235594e+00 -1 -2 0 +371 1 3.1656541571472099e+00 8.2451918974189500e+00 8.0415029551628514e+00 1 -1 1 +186 1 4.1675976318493086e+00 8.3247658596031009e+00 7.8802494669419030e+00 1 -1 -1 +413 1 6.4945159878598346e+00 8.3677431053238660e+00 7.6981134933049891e+00 -2 -1 -2 + +Velocities + +7 -1.5197672199477208e+00 -7.1031250708487148e-01 -4.0950627961412567e-01 +398 9.4644999179644840e-01 -8.0422358764146151e-01 -1.1023964746841350e+00 +173 4.8084218242595870e-03 -1.9383808513915850e+00 9.3439099328992314e-01 +462 -1.6390116924948674e+00 -1.2080683544699562e+00 7.6685759600965364e-01 +383 1.2945118204202577e+00 -1.8370931432093225e+00 1.1758972656982776e-01 +288 1.2113220352829337e+00 4.8786819623543370e-01 7.1439798712590263e-01 +303 3.6232856211831610e-01 -3.7927260062054236e-01 -3.0467891118546553e-01 +491 1.6817821327211264e+00 6.3153250223994289e-02 -5.4827183875981267e-01 +187 5.6164532616475686e-02 1.3250338697636479e+00 1.6291294556417517e+00 +163 1.3950518510134631e+00 -1.7090097072259662e+00 -6.0029200570353536e-01 +345 -8.4635427449528189e-01 1.3013642733988193e-01 -3.7582537476409439e-01 +447 -5.5306523194731427e-01 -1.4583063079290524e+00 4.8086237208854654e-01 +108 -3.1879632824306825e-01 -4.9387838912491844e-01 -3.1046215530949173e-01 +427 2.4456665882970424e-01 1.3737057789182878e+00 -1.7474218101951866e-01 +96 -2.8217287015277487e-01 3.9138367367476778e-01 -4.6114700958040086e-02 +494 3.0303709765292064e-01 -9.2861341821366045e-02 -3.6692009603190118e-01 +360 -4.2709052063514102e-01 -1.5167804301477015e+00 -2.6902074926466563e-01 +179 -1.2403873183879999e+00 1.1368400311662936e+00 5.6653449328883521e-01 +136 -1.5859168963178476e+00 1.0728794555657983e+00 5.0876417522892092e-01 +311 -1.4232560247874224e-01 -8.2802934475265932e-01 1.0289469027582252e+00 +242 -1.3753994053365912e+00 3.0823812109914095e-01 1.2519475129774249e-01 +451 1.0684545083916284e-01 -1.3647250068831975e+00 1.2292458701523420e-01 +118 6.5344809858683794e-01 -6.0529931820910909e-01 -6.6821572295625731e-01 +200 -9.1497459004230530e-01 -7.2783581485393822e-01 -8.5265666689286446e-01 +23 1.0121027757280427e+00 -5.8690115135784995e-02 -1.4283745590726701e-01 +30 -1.2406061152582815e+00 3.7490020292637088e-01 -1.4457935973251330e+00 +26 -9.9581994312158117e-01 -1.2441026541932486e-01 -3.6541440712112250e-01 +452 -9.8588039362152369e-01 1.0706468502992672e+00 1.6282162085617651e+00 +439 -1.2386761163593085e+00 4.3106305328993799e-01 5.0410115305724934e-01 +492 2.7094066326642935e-01 6.6318883302565457e-01 1.5999014287193769e-01 +287 -1.7254693201510321e-01 1.1189096817152451e-01 4.1489954379924110e-01 +87 -1.1416496451717975e+00 -7.8732701356097490e-01 -5.1553483379997289e-01 +191 1.2771897324335735e+00 -1.7496443253093807e+00 5.0507874089360993e-01 +316 9.1440987552186193e-01 5.4700363415289210e-01 9.8622452705158947e-01 +176 1.8575029150961730e+00 4.1139607157872565e-01 -7.4590595351664335e-01 +244 -4.6943526746297531e-01 -4.0598167955478592e-01 1.2148844546685273e+00 +463 -6.0334643189530614e-02 9.0710610807033173e-02 -1.1159129056326442e+00 +101 -4.6185710842519001e-01 -1.0745733134156132e+00 -8.4095960640252343e-01 +456 7.3559492687866046e-01 8.4585098605759870e-02 9.9419285892741016e-02 +90 -6.9201778873218364e-02 4.2798282427303436e-01 4.4566581747153294e-01 +457 -2.4132420839469965e-01 8.4836564798364844e-01 1.0955942184355154e+00 +344 6.5538410556645377e-01 1.0527852545027427e+00 6.8154568558028386e-02 +399 -8.3144103937947644e-01 1.9062875610231711e-01 -5.6419101062513155e-01 +472 7.2667243545881360e-02 4.9535613585667015e-01 8.3691870718219108e-01 +364 -2.9526170592863293e-01 -8.7862728527604539e-01 8.2689159018968139e-01 +333 1.7241045239522232e-01 1.0435495829586168e-01 -4.6109306717747689e-01 +223 3.7919285550573256e-01 -1.0672385659469772e+00 3.6984147519214111e-01 +277 -8.8028901289995187e-01 5.8075379122029680e-01 -5.0555689035944396e-01 +487 1.5229361655153211e+00 -4.3334638823410909e-01 -5.2025315373818937e-01 +202 1.1890248672755632e+00 -1.3103428543183313e+00 1.3877359082264291e+00 +139 -3.8593619396281981e-01 -4.1419081865118412e-01 4.8341157555249414e-01 +218 -1.2190042149414249e+00 8.6603581070857749e-01 5.3180226853912571e-01 +10 4.0346230429792890e-01 8.8022045895227152e-01 3.0611723210999553e-01 +64 1.0687583963535543e+00 -2.5590555538042992e-01 8.2852453062456832e-01 +40 -1.0543471069223134e+00 -7.9810717548135568e-01 1.4389073785681245e-01 +328 3.2979243925573831e-02 3.1076559402174242e-01 -1.6410904905031269e+00 +292 -6.3224783054646483e-01 -4.3704038413109603e-01 -2.2759444134328080e+00 +245 -4.7869651996764956e-01 1.4231085014444791e-01 -1.0109564296885869e+00 +148 -7.1011989912373741e-01 -6.8437374624235792e-01 -4.7084060341785217e-01 +435 -2.3710180935788738e-01 7.3150957873543554e-01 1.9569288343148944e-01 +301 -7.3626400316656140e-02 -1.2518892197053937e+00 6.4938262930099341e-02 +476 4.4522311443074564e-01 8.4413304640745324e-01 6.9180275295562699e-01 +310 -4.4579106235383259e-01 -1.4870237388818175e-01 -1.7519046471808755e+00 +137 1.0191269790481958e+00 -1.1871217736355175e+00 6.0687187776921336e-01 +434 -8.0977924479936902e-01 8.2445677967490594e-01 -7.2982619204505017e-01 +184 9.3329968718567657e-01 -7.8960961760367476e-01 -3.2387020805541877e-01 +5 -7.6591643318776403e-01 4.4567507028100856e-01 -5.1504861374485367e-01 +41 -6.0827814801341495e-01 1.0335818250945215e+00 -1.4262577781586459e+00 +410 5.1617643329833041e-01 -1.2505433325731774e-01 6.5548767709779598e-01 +418 7.4452116863445517e-01 5.5176595694257291e-01 4.8433486134467341e-01 +34 -1.0960797951083094e+00 -9.5559899011366922e-01 4.1467430632337771e-01 +67 -1.4762168791195980e+00 7.3902009632630203e-02 -9.8563314451155759e-01 +390 1.1040922756330935e+00 -1.0608530270906485e-01 -8.5480860400114822e-01 +125 1.1001683944330445e+00 2.5213959563273414e-01 -7.0907876564322847e-01 +105 9.3642884637919491e-02 3.2241122070134182e-01 3.4267503174724429e-01 +274 1.4805711826308454e+00 1.9591264275732104e-01 4.6208005550476272e-01 +314 3.3724005635036658e-01 -4.9228354871213487e-01 -5.9105855919176131e-01 +408 4.1789097671328662e-01 2.2054753884758851e-01 9.9409268338014201e-01 +142 1.3529751978153088e+00 8.8819247946851643e-01 -2.9699787225611667e-02 +25 -3.6747378202427655e-01 -1.6653943785151797e+00 2.1594786196965424e-01 +458 -7.3004682150577682e-01 -2.5761460079892318e-01 -7.5492049253862104e-01 +165 -2.6776300065898789e-01 -3.1428309412647404e-02 7.6464836175889062e-01 +421 -2.2112566002008222e-01 -8.0033416193571816e-01 7.4057822704117926e-01 +151 1.6510010513742961e+00 6.2880202489514836e-01 1.3109463507573997e+00 +162 8.6466591751463506e-01 1.2003096922919751e+00 1.6720745976940152e+00 +120 7.1544273833415639e-01 7.8605685992147967e-01 1.5756692842267452e+00 +448 9.4818399052933544e-01 2.0373333697562079e-01 1.1821449360296239e-01 +50 -7.4255028295716818e-01 3.2131856627302258e-01 7.0344624031236247e-01 +443 5.1965861871733798e-01 -1.0469002555669342e+00 4.3373559100868195e-02 +482 1.9661775056161916e+00 1.8911734358361203e+00 7.2949567046678088e-01 +407 1.8582263860937767e-01 -1.3051257268383373e-01 5.0987931207045945e-01 +100 -3.7775697318477114e-01 6.0919017017007682e-01 7.1809182324625254e-01 +99 -1.2684617496938173e+00 7.3671717137305515e-01 -8.1216571664258830e-01 +107 -2.8776644836089277e-01 5.0874100972210130e-02 -4.8277793530428115e-01 +480 -1.8051331679926971e-01 8.6563042329278228e-01 -5.8352716569019136e-01 +115 -1.0589943552297505e+00 -5.2550981762149152e-01 -1.7244688387853080e-01 +278 1.5768829958501078e+00 1.4428098110470169e+00 8.8216722790329116e-01 +206 -1.3653407453215169e+00 5.7341428096126357e-01 2.2629859809279146e-01 +4 4.2054817038258185e-01 -2.9390858515089308e-01 -1.7875237254421117e+00 +214 -1.0426854223671351e+00 -9.9898728143962490e-01 -1.9850479848636837e-01 +65 4.1792586017239108e-01 8.0186431881714215e-01 -2.0107060384389590e+00 +490 6.7355251805377303e-01 -2.0698786089395388e-01 -3.1564646838967253e-01 +230 -1.3855973935201399e-01 1.6134941051796734e+00 2.3723214232474421e-01 +234 1.9442134326447673e+00 -1.3805634063343805e-01 -9.8210270774821284e-01 +92 1.8063255781217027e-01 9.3716955232457000e-01 -1.9187798219061411e-01 +103 3.9559605419305116e-01 -8.7523159162324915e-01 -8.6993815784441930e-01 +129 1.2253789920819727e+00 2.8171983713246046e-01 -1.2180024131333584e+00 +483 9.6349992375661320e-01 -1.6348662648160852e+00 8.3712630375667085e-01 +110 8.0468512955471783e-01 -1.2623668571621947e+00 1.4617362498240638e+00 +126 -2.5741602043303030e-01 -2.5870568275485217e-01 -1.0282926023825125e+00 +276 7.0448925295125497e-01 -1.4486777483518087e-01 4.0589927727544634e-01 +294 4.9277474123671205e-01 1.0788251906341033e+00 1.0720476037391911e+00 +417 1.2134126298835348e+00 6.9341902173441838e-01 -6.5915650495314448e-01 +102 -9.4530772564542864e-01 3.5633646308084904e-01 2.1645216652503570e-02 +228 -3.1477177829390662e-01 -7.3015136189998553e-02 -1.3550661516185267e+00 +2 -1.5167590438599203e+00 3.2942906513575698e-01 -3.9430403043809092e-01 +222 -3.4853423639550507e-01 4.3402827204271471e-01 -8.9055344775375656e-01 +332 7.6671266929186610e-01 -4.2789189576138797e-01 2.2589706911206284e-01 +275 1.0091776783462640e+00 -2.3875723103898955e-01 9.0625273137588058e-01 +243 -2.4008164703199580e-01 2.4602229249214927e-01 -9.2542387373274426e-01 +394 -1.5496683613302659e-01 -1.4731622236607285e+00 4.3712483588631723e-02 +325 -9.9716991278750156e-01 9.0079916710328489e-01 6.1656781470423368e-02 +468 1.1367478364774437e+00 3.7268550263787792e-01 -1.9334998928228118e+00 +113 -6.1637943298580211e-01 -1.4259739417714792e-01 8.5880390205968704e-01 +47 1.4522907038923785e+00 -3.8138661441744320e-01 8.8902241399148096e-01 +474 -6.5326939744671464e-01 -2.9584216080544323e-01 -1.6703076347144621e-01 +343 -2.0865957540293453e-01 4.2320136734663144e-01 -5.2417372636564219e-01 +257 -1.6598412047016537e+00 3.9614126419385248e-01 6.2190463287430520e-01 +422 9.8621254947118736e-02 -4.5653326655140536e-01 -1.6959752095102018e-01 +317 8.1554926779727022e-01 -9.3952932101149422e-01 4.1213701483558629e-01 +322 9.7692194337623842e-02 7.2221211185210599e-03 1.4983319825497168e+00 +453 1.0112117753398511e+00 -1.6043121320019077e-01 -1.5109389287188097e+00 +82 -1.8245270960375951e-01 -1.7227940931260219e-01 9.4914460423273084e-01 +402 -1.3974163926710530e+00 1.0238276956317611e+00 -2.7116721725643461e-01 +201 3.8154565319070316e-01 6.1162789639306392e-01 5.3616806651343329e-01 +159 -5.5623509138788352e-01 -7.3506001159846490e-01 2.9669217335717424e-01 +239 -1.1703971851987414e+00 -2.5624748584715568e-01 1.9987978519039629e-01 +340 -1.1651635328367398e+00 1.4923285973929103e+00 -5.0638764373602618e-01 +246 4.6916366638116123e-02 3.7471219463751682e-01 -8.5595777185358435e-01 +268 3.9776335718715750e-01 -4.1326407010466332e-01 6.4132644428253849e-01 +238 -1.0102989663900468e+00 2.5145560602393102e-01 1.6537809300909093e-01 +183 9.6649446422314420e-02 -3.1320299584600791e-01 8.9787784698607254e-01 +393 -8.1709715097020719e-01 6.5173585509788723e-01 1.3340272254613436e-01 +177 9.2862946550951486e-01 -7.4734865012317631e-01 2.6370187436425798e-02 +97 4.0324698775550633e-01 -6.5060630846020162e-01 4.3381661619662121e-01 +16 9.2225588537666714e-01 5.0761227093429218e-01 2.8224038915514177e-01 +15 7.4631799122735776e-01 -5.1735298399747642e-01 1.0267699639319139e+00 +467 2.9233724948217432e-01 -1.7768548355681282e-01 9.7602334864839035e-01 +404 -1.5591392530118275e+00 6.9331308976828065e-01 -1.9156738913640683e-02 +190 -2.3293475783192552e-01 1.9804103372721136e+00 1.4400561196029799e-01 +429 -3.1240905856412571e-01 5.3399975662794008e-01 -8.3672459106253427e-01 +356 1.1813499076138427e-03 4.5712322524667531e-01 7.2569550209608535e-02 +459 -8.2536401218028255e-01 -5.1587534016495484e-01 -3.2429633054579987e-01 +140 1.4169132709847332e+00 -1.6948863471126016e-01 -5.4590188862129563e-01 +121 -8.0623019357608017e-02 4.3956025735145637e-01 -4.1230464603429395e-01 +76 1.2149513180720075e+00 3.0664283974167705e-01 -6.2206166881984115e-01 +24 -9.0953792569391767e-01 2.7208504534230199e-01 -5.7968255809907288e-01 +215 -3.6635366137979941e-01 4.9083544993599626e-01 5.4540399677247620e-01 +406 -2.8711421371139068e-01 9.8028410382686626e-01 -1.5688211456737056e+00 +495 -2.6064405757207798e-01 1.0014422650657693e+00 1.2195244915445839e-01 +256 5.1502433217852350e-01 2.1618101498582329e+00 -5.5671498574760148e-01 +348 1.5303758850601952e+00 1.3538700733088898e+00 -1.0404602147830582e+00 +18 8.7092721144608365e-01 8.8296303804909981e-01 4.7076145062566271e-01 +259 1.2579194534410862e+00 1.1275351076124240e+00 1.3255628670657002e-01 +261 -1.9457509303164215e+00 -5.7013962206489510e-01 6.5787967104563000e-02 +433 9.5143226323949670e-01 -1.9787864106930605e-01 2.1852616176467912e+00 +119 5.2387728877999162e-01 -7.5008900728698324e-01 1.0156553043596699e+00 +181 3.6547537534957092e-01 4.4856602347738611e-01 1.9502787843157898e-02 +392 1.8883706922750969e+00 1.0836617564317459e+00 6.8587165903540392e-01 +436 -7.5639783907079583e-01 -6.1811736982444421e-01 -2.2826839230281426e-01 +210 -4.5965909404278121e-01 -3.3285948977797364e-01 -2.8815683118847368e-01 +409 -8.9630394160430427e-01 1.2498156320615575e-01 -5.9486610361558201e-01 +437 -1.3458244785393264e-01 1.1611540390359226e-01 3.6707571520967769e-01 +114 -1.1780626363780731e+00 1.1424256338126497e+00 8.1898562672334474e-01 +431 3.9295632541408759e-01 -5.0466339464883803e-01 7.4701651109545830e-01 +296 -2.9562979314792992e-01 9.3794387166245374e-01 4.3821394647736267e-01 +477 -1.0332993738194893e+00 5.9732959339716152e-01 -1.6990304505644747e+00 +199 -1.0627414724922077e+00 3.6527741326574337e-01 -5.0076911469807539e-01 +31 1.1836258822972918e+00 -1.1805527709262840e+00 -1.0148440310730218e-01 +149 -9.7152762187442065e-01 -8.2689424175864179e-01 -9.8308725322137946e-01 +216 -2.6635793686817422e-01 -1.1249304826477751e+00 5.2675272099922754e-01 +425 -2.8287490221194594e-01 4.1086346332975782e-01 -5.6774387340250076e-01 +224 -6.3636066584070272e-01 3.8927738472590379e-01 -1.2043299828812322e+00 +352 -6.1634031766701480e-01 1.9344774717790295e-01 7.8374630494614250e-01 +289 -9.8440193523267117e-01 1.4471012647779624e+00 4.3922631035860088e-01 +455 -1.1942412759322272e+00 1.1300600257912083e+00 -4.7958784865825908e-02 +298 -8.4955866984285322e-01 1.8131854984076790e-01 -1.9010434504555735e+00 +42 1.1523609145851870e+00 1.3198909771653919e+00 -1.1943568765046571e+00 +80 2.0928302112510155e+00 -1.9281727715628849e-01 3.5879525261694012e-01 +127 1.0275071129063864e+00 -7.8560029105042173e-01 8.4680312545585235e-01 +232 3.2836195573764693e-01 1.5921754951459595e+00 -1.4889040346123832e+00 +368 -1.0143580013676627e+00 -6.3286772474382025e-01 5.9003271203631313e-01 +486 3.0052735920053437e-02 -7.5917073216074904e-01 -4.0707609210832352e-01 +209 8.3084043466989521e-01 -1.2819860426930157e-01 9.8450910112172252e-01 +152 1.4018503697498572e+00 -1.3364969077798206e+00 5.1589841760235022e-01 +353 5.3822763779176630e-01 -4.8322987719532096e-01 3.5634065895494110e-01 +361 6.8264929410893807e-02 -1.3682995245096907e+00 -4.9273501999153174e-01 +391 6.7065636846264776e-01 -2.7904582963633018e-01 -6.5303896626046076e-01 +464 7.4567031841775322e-01 1.8046977002555891e+00 -3.9159771733015164e-01 +497 -1.3856699033357778e+00 -9.3599081481125368e-01 1.8204759707532270e-01 +498 1.0568629143757213e+00 -6.8137997517450560e-02 -3.7037143049187105e-01 +264 -7.7894167957263005e-01 2.7383401106980504e-01 7.5098074183721675e-01 +265 1.9614235016832940e-01 -4.2322665725562197e-01 -1.6236881765469688e-01 +350 -6.3256317352651559e-01 -5.9660876051471468e-02 5.2317095757618959e-01 +144 -2.0800773378554721e-01 -1.5156540919629388e-01 -1.8814379829548375e-01 +17 8.2103760580927843e-01 -1.1053143150308307e+00 1.1843881143235824e-01 +441 9.9191589104231870e-01 -1.9479579195707514e-01 1.8130903870970541e+00 +266 -9.4957121369000017e-02 8.6997989048119007e-02 -1.5903074475142429e-01 +375 8.1973242957273296e-01 1.0075441532082390e+00 6.6277118207442265e-01 +351 -1.0694047025049973e+00 1.2185457298237026e-01 7.2731979237547140e-01 +254 -1.4178061472233576e+00 1.0044925984667965e+00 5.9999609355847139e-01 +29 4.7548776272319854e-01 1.5001558567759110e-01 7.4645778473548241e-01 +198 5.7218364285113010e-01 2.9196622753924861e-01 -1.2231490460337893e+00 +197 -1.4204377171882598e-01 2.1322055429678972e+00 3.5360172437812271e-01 +192 -4.3230000337254881e-01 8.1753260459826260e-01 -1.3961239427992276e+00 +220 9.2338173032465304e-02 7.2444278115958327e-01 4.3240465996750244e-02 +432 3.3837153168712325e-01 1.9757543957217949e-01 -3.2138599665961831e-01 +20 7.2972771576502227e-01 -7.1923547937920451e-01 3.8462300862783037e-02 +63 7.3459759072459618e-01 -2.1393390343408181e-01 1.4606085672716668e-01 +446 9.5489174587921177e-01 -2.2284752482645742e-01 -7.3147917056258960e-01 +172 -2.3233356067616504e+00 5.9696639792861073e-01 1.0311292046090428e+00 +405 -1.1779705391325133e+00 2.7846640825986735e-01 9.6440591359561623e-01 +323 1.2758508066094825e+00 1.1576865878083721e-02 1.3415986450967126e+00 +428 4.8021126796596170e-01 4.8003440312842205e-01 -4.1979524804611819e-02 +280 1.1723141734791545e+00 8.4290272518839332e-02 1.1240738308596074e+00 +54 8.2234236592018339e-02 6.9377897211693754e-02 4.6415665343815465e-01 +397 -2.4516753222359439e-01 -3.8647076314136586e-01 -3.1938187998240442e-01 +279 4.7475740365710301e-01 4.2033019401821775e-02 1.0791025172609856e+00 +134 4.6986570792330234e-01 7.5759398359663410e-01 1.3748348906115773e+00 +236 -1.4338534270949166e+00 6.5242359063738475e-01 -4.6879001422000049e-01 +493 -9.5795155221589912e-01 -9.3131490174346532e-01 5.2848598027407112e-01 +346 9.4017276609564226e-01 -1.4423054432512394e+00 -3.4883627652283825e-02 +295 -1.0211326704350645e+00 -1.5688283678435537e+00 2.2737881805456114e-01 +164 4.2933435120637192e-01 1.2908919636558716e+00 -1.8559649323965055e-01 +354 3.1232180266110654e-01 -3.3884174823706786e-01 2.0012570054806617e-01 +449 -4.1956545717722271e-01 8.5033185910749320e-01 -1.6923286514167504e+00 +185 -1.9847768794898153e-02 1.6093024328157031e+00 -3.4278049008935008e-01 +229 3.3354615877618454e-01 -2.1967770508754222e-01 -6.8288738508757751e-01 +135 -3.8598562184690355e-01 2.3459455181853697e-01 1.4591795655915993e-01 +211 -1.1858788850370010e+00 1.3960363241794649e+00 1.1390210005059993e+00 +81 1.3604301094625607e-02 1.2711357052370638e+00 1.3840699383718491e+00 +37 3.5025606454523878e-01 -1.0316562604143946e+00 2.4944393037279400e+00 +355 -4.2713554752038259e-02 1.6441819966987897e-01 -8.2550044716409909e-01 +141 8.1569462514471880e-01 -6.8558748209733145e-01 7.0575287639668483e-01 +122 3.6274405429300222e-01 -4.1985688325391463e-01 2.5223429679090231e-01 +327 5.2689568302324030e-01 -7.1530570005039407e-01 8.1591540939993761e-03 +386 5.2540176252260506e-01 -8.0891002493580211e-01 -2.1080798818740659e-01 +59 3.8008676468324715e-01 1.2302042558959829e+00 -1.2893140123247515e+00 +57 -1.2756375464672689e+00 7.7885421584605408e-01 9.3218921154320622e-01 +489 -4.8772350194378145e-02 1.1774319824237183e+00 -1.3413963962772402e+00 +326 -8.2073133946066312e-01 -1.2685275916429064e+00 -1.0253535003668284e+00 +359 -1.8991447869255085e+00 -1.2154594584519982e+00 -1.7832247863578221e-01 +349 6.4100123949028309e-02 -3.2723074072385872e-01 -1.5565659217165477e+00 +247 4.5734576435732799e-01 4.9511064545143885e-01 -1.5945768728559153e+00 +365 -5.7917383718454207e-01 -2.3494837692508375e+00 -1.5004840205862926e+00 +382 -1.0813649655944142e+00 4.1831946020927230e-01 2.9306887264755938e-01 +130 -5.7488571729114812e-01 -9.6638702807104448e-01 -1.0278487271582966e+00 +471 1.1085411185196428e+00 -5.2404573748396321e-01 9.9734211160337760e-01 +21 -2.3901903994255250e-01 9.3578484419611557e-02 -7.3719660959071831e-01 +499 -4.9906801820206043e-02 4.0499214176262377e-01 -2.9371307883695258e-01 +253 -7.8928864460108283e-01 3.3838305995790624e-01 7.1275694444227405e-02 +302 1.5254343639867396e-01 -2.7881674166920268e-02 9.3627888140226589e-01 +324 -1.1159492478288651e+00 7.0632546920242867e-01 2.5394407536700253e-01 +154 4.8736880051344117e-01 -1.3177717741071062e+00 -7.9660620460177323e-01 +284 1.7716036485389025e-01 -3.6539348914929748e-01 -4.6941135291661629e-01 +161 -2.7479275242316997e-01 7.6982156884799513e-01 -5.7088165723862649e-01 +112 2.7023059482372042e-01 2.0487127767495705e-01 -4.9350658197380731e-01 +39 -1.6840134362063963e-01 -2.0596641915022665e-01 1.2622422574022685e+00 +269 -1.4448376822412348e-01 4.2047192520573229e-01 -1.5751711248887881e+00 +470 -9.0198936075875380e-01 -1.0035762705605118e-01 1.1469701649179411e+00 +84 -3.7165102348228596e-01 1.5718083932531206e+00 1.8715295090631173e-01 +381 6.6740577340943863e-01 -1.9432536761932276e-01 -1.2757754863002870e+00 +416 7.2118119300841677e-01 8.6813375765446710e-01 -8.2350198387929519e-01 +182 3.3694648494832763e-01 -6.5830649973844163e-02 7.0076361524788766e-01 +347 -2.4949061953800500e-01 -1.1432286442922379e+00 -4.5757988288631407e-01 +380 -4.7143472726668367e-01 -2.9180051952103941e-01 6.0581680882348110e-01 +19 7.3007216948068054e-02 9.4947888518620716e-01 3.4627576178512598e-01 +430 -2.2320112834958328e-01 -3.8559102989803251e-01 1.0427665572858709e+00 +212 2.0170777345036919e-01 -9.9332505765821755e-01 1.0550787824425254e+00 +479 -7.7910620356048310e-01 -3.4759422268929079e-02 -5.8756871125828891e-01 +217 -7.0999315500035393e-04 -1.4874035841198494e-01 -1.1389898361525996e+00 +147 3.3953282916732841e-01 1.0503362153417393e+00 8.8554338624429496e-01 +13 1.4952012032076418e+00 -1.3492024227588162e-01 8.6834761707295621e-02 +170 -7.5230462228731629e-02 1.9875829136564169e-01 3.8512887113920530e-01 +204 -3.1459152727076800e-01 -7.2066080044499392e-01 -7.5277710665622377e-01 +306 8.0529112138128323e-01 5.8633344712571456e-01 -1.8256367575393391e+00 +414 -1.7678147014996259e+00 -7.1706970804552028e-01 6.0614094017430153e-01 +79 1.6303375369704216e+00 -9.6446702691566244e-01 1.7014099837302679e+00 +116 -1.7231587507489068e+00 -2.2374070614774770e+00 1.0442058418221465e+00 +231 -9.2546402309298947e-01 3.2157716287919585e-01 -6.2797312032694141e-01 +171 1.4243635122212095e+00 -3.4034411127116748e-01 2.1060050313379719e+00 +273 1.0777993506600285e+00 -1.7160435918146213e+00 1.0194335249558832e+00 +260 1.4544392536719453e+00 9.3765863648494707e-01 1.9642995061847701e+00 +43 -1.1326443879098980e+00 1.4846909715454837e-01 1.6874301063514463e+00 +208 -1.1234489793683757e+00 -1.0408587064067447e-01 -4.8386417041968832e-01 +226 6.0458834484750512e-01 -4.5998597100022531e-01 -4.1420588246526679e-01 +370 -2.5264443636161833e-02 2.2888129565845829e-02 -7.5123334633027034e-02 +85 8.9124431006375637e-01 1.2150234901900336e+00 -1.3794080039677503e+00 +213 6.8750004752856542e-01 1.7643443473184617e-01 -7.6039731517372366e-01 +299 1.1166507011383160e+00 -6.9342398354435130e-03 4.0031150060326554e-01 +249 1.6676259701674601e+00 -1.2916011404415280e+00 8.3081388251616040e-02 +258 -3.3338543070706111e-01 -5.9677208925291603e-01 1.5474505568531705e-01 +388 3.3338877926510010e-02 3.6534261356710357e-01 -9.3163626937108668e-01 +91 -1.0436539497197659e+00 -3.6206368573074071e-01 -3.9406149981573330e-01 +415 1.8022253921012549e-01 -2.5361248238828202e+00 7.8761564433010600e-01 +27 1.6681493439613866e+00 -6.3832374162264238e-01 5.5825898158707521e-01 +465 -3.3883292906124979e-01 -1.9199928938047977e+00 -1.8916637827626086e-02 +72 -7.0256791239588934e-01 -1.3631374858756479e-01 1.1539466869530803e+00 +58 -9.7431680335045678e-02 -1.0635351953490649e-01 -4.5168665276313896e-01 +88 5.2937320884954953e-01 -1.1749454649084838e+00 1.2744645330784524e-01 +6 -1.1593774469007843e+00 5.1413980407296589e-01 1.2944389470552302e+00 +75 5.7374690805841033e-01 7.8433587872715163e-02 -3.9368611836917572e-01 +22 -9.6996881290452630e-01 1.2965746977075312e+00 -1.5394575986278033e-01 +128 -6.4070276272082638e-01 2.2708380115440285e-01 -1.6142126045669323e+00 +193 5.7443781554989515e-01 -1.2458447329459237e+00 -9.3796775534017041e-01 +389 6.7276417854677451e-01 -2.9571653479618748e-01 -2.4423872850138906e-01 +241 -1.4102001294916395e-02 -9.9059498112109945e-01 -8.4827835518272399e-01 +14 1.0515231184651945e+00 4.5617222115757200e-01 -5.2911246318135385e-01 +307 5.0028759749137040e-03 -5.0699437336696396e-01 -2.5790615969461578e-01 +401 3.9207473498457289e-02 -9.2058641117610335e-02 -1.3689269955592848e-01 +248 1.5980225324156891e-01 -4.1600725109692227e-01 4.1253240562945254e-01 +335 5.6526042010051392e-01 -1.0563866873458263e+00 2.2963431232103770e-01 +281 4.7335967523683825e-01 -9.8764893385752195e-01 1.3275577965292436e+00 +33 9.5713349527393091e-02 -6.7578402785937589e-02 1.2308478723868863e+00 +221 -1.2080117435798665e+00 -2.2142477880517361e-01 -7.4060132361069042e-01 +251 5.1352069062594478e-02 -4.7173153686079722e-01 1.3645828375870801e+00 +138 -9.8931419992230929e-01 -5.6403083699472267e-01 4.8437720371021081e-01 +73 -8.7238230525929461e-01 2.2619668651197614e-01 -3.2904255863286136e-01 +237 1.5966476021876643e+00 -1.0734521639966819e+00 -5.7008225474518526e-01 +77 -6.5731386120913948e-01 -1.3672574981662913e-01 3.4397972232069346e-01 +339 6.8164227902965080e-01 -8.7654828372118265e-01 -9.2289632523091991e-01 +69 -1.0710495228647499e+00 -2.2798359247984892e-01 -1.4017813863798740e+00 +150 1.4728554201464288e+00 1.6873571351133543e-01 -4.9418642333439719e-02 +219 3.5347912349947574e-01 1.9808724875609746e-01 -5.0625815831733678e-01 +9 6.3426493841071574e-01 2.5658018877632760e-01 4.7953937763858034e-01 +3 -1.2144659411870629e+00 8.8297859772359033e-01 -2.6732917639533704e-01 +93 3.3822789154655764e-01 8.1143107440094409e-01 -2.7263548606070248e-01 +68 1.6351351046383883e-01 5.8445604848527588e-01 1.2062643207337951e+00 +35 1.6550671586466750e-02 1.6790869037398232e-01 2.5947900830558479e-02 +174 1.4403688502275100e+00 1.4476094634256031e+00 -1.0038411182890872e+00 +369 -7.9303772394565375e-01 -1.1303432398125628e+00 -1.5457440975201582e+00 +469 -5.5239153419630294e-01 -4.7075634498045837e-01 5.0539291079888571e-01 +270 5.0351525849727374e-01 1.3716919044917866e+00 2.8157430421583601e-01 +196 -2.2101193763774998e-01 9.4257812877032954e-01 -1.2881024224381614e+00 +235 -3.7410168233289759e-01 1.9712488864630789e-01 4.3505985658493368e-01 +104 1.0770774810232915e+00 -7.7420116923795979e-01 6.4885799952777634e-01 +363 6.7513909705285891e-01 2.0186757605257277e-01 6.2260156794788402e-01 +440 -2.7563401138205812e-01 4.0196589304635166e-01 6.8696509786942431e-02 +271 3.5486339796858996e-01 -1.0482634846478769e+00 1.0693870635001128e+00 +385 2.0653637543135839e-01 1.6251902525248125e+00 -1.0240800582063148e+00 +367 1.2090890730479817e+00 7.7304993739281713e-01 -9.1196492155951403e-01 +8 1.5650406952874099e-01 1.4761853226272020e-01 7.1667065222651671e-01 +445 -8.1712119890107360e-01 5.0169175756271378e-01 6.3236875667481124e-02 +95 7.1388432342661989e-01 -2.6058252368101411e-02 -1.0159428151424379e+00 +227 -2.1897046900910261e-01 2.4492515107534649e-01 2.2679621024062299e-01 +45 5.0120245022687604e-01 -1.1380921868404339e+00 7.8232214243213327e-01 +62 5.7973338245234629e-01 -7.9117819757367913e-01 -5.4327640325878901e-01 +309 5.3715909018265540e-01 -1.7844975395461696e-01 -1.5521878040430610e+00 +70 -1.3649193486754410e-03 -1.5242800010205164e+00 1.6225001176581824e+00 +285 -1.5639729724408871e+00 1.4626366106935738e+00 -1.2286649953661322e+00 +387 -1.3226131489884976e+00 -1.0695489941103238e+00 -1.4911056977700106e+00 +484 -1.5087954881419843e+00 -2.3407968100714568e-01 8.9471716161806181e-01 +98 3.0624993702155973e-01 -1.5934008419723134e-01 -1.0700290072035785e+00 +282 -1.1678279208732874e+00 8.8816716100523774e-01 -3.7594379985472404e-01 +203 -1.2339287833422024e+00 -1.0851718286318821e+00 -3.5581216293468138e-02 +189 -2.5647410293058537e-01 -3.6970804452537526e-01 -2.7009745024499721e-01 +267 -2.3687566231483211e-02 5.4572876490146272e-01 1.2664988400691950e+00 +155 1.7966821085178111e-01 -1.4254017034472058e-01 -1.0614594824352175e+00 +313 -4.0833555690731410e-02 -4.8193546027639250e-01 -4.9602679807507655e-02 +250 4.3395781720710452e-01 9.1543705256636054e-01 -6.1780594432179192e-01 +49 -5.8496932778818223e-01 2.0845066341835794e-01 -4.5660091846264866e-01 +111 -4.5577164923909808e-01 6.7687347516731056e-01 1.6901306317755600e+00 +124 2.3017035971304120e-01 1.2116381200880159e-02 -1.0715278739263430e+00 +488 1.1047027896127255e+00 -1.2726762145955062e+00 7.7913777050672761e-01 +48 -4.0669146183799126e-01 -1.0181831306551499e+00 6.3005463620771884e-01 +123 -1.2387342693749222e-01 -4.5460712390743935e-01 -5.6241811130968811e-01 +423 1.5051226831159246e+00 -1.0959205280256621e+00 3.5512567969767117e-01 +329 1.5695087401093555e-01 -4.0810545929224507e-01 1.5430948869435961e+00 +334 -1.0908322951892016e+00 -5.4577269465148259e-01 -6.7521769754195848e-01 +146 4.4361993166914260e-01 4.1962079818012665e-01 -3.9049661615798353e-01 +500 -3.0319085884539942e-01 7.6039240701443311e-01 2.0836797720615632e+00 +46 -3.9431430053902639e-01 3.7259615958614579e-02 -1.6080049457594121e+00 +374 9.2250275913940816e-01 -5.4107808677407720e-01 6.5542912197165987e-02 +52 7.3216124676172201e-01 9.4572980131871298e-01 -1.2696251833719743e+00 +466 1.5044833940669236e+00 -1.8483350803538756e+00 9.5057050040256286e-01 +272 -4.0011978947412463e-01 2.0429884556820119e-01 5.4991808303431688e-01 +331 5.7814259377466726e-01 1.7044411336854475e+00 -7.2986308719737536e-01 +12 6.8240059668147224e-01 8.7756006768431916e-01 -1.7546792723746987e+00 +178 -1.1529369201979585e+00 -3.9576843637993819e-01 4.1654001054549866e-01 +376 -1.3678465511836193e+00 -1.5404423718061540e+00 -8.9187926122069050e-01 +117 -1.3804354656475164e+00 -7.9075263667417661e-01 -3.6776627245391275e-01 +419 1.9706999335859632e-01 -1.1815264434314889e+00 1.6458873301525292e-01 +379 2.6784097653047051e-01 3.8806722276897926e-01 4.0603233211791162e-01 +53 1.0521966172519035e+00 5.1164934479578683e-01 9.8577725800730365e-01 +28 1.0129347774638686e+00 1.1058165761432928e+00 -3.9034581257989903e-01 +300 -1.4876024382598509e+00 -6.2467982655378396e-01 1.3535210035045362e+00 +83 9.7907832581926901e-01 1.4855763621624507e+00 4.1007013403839504e-01 +304 -1.8963384707907098e+00 5.2731582964002444e-01 1.0962854464287259e+00 +51 8.5928138726119452e-01 -1.6162178311396377e-01 3.2746315986045632e-01 +180 -3.4136546641226267e-01 1.2771151944969144e+00 -3.9578085701206223e-01 +60 -1.7295103304379962e+00 -9.9492157200179920e-01 1.2224650147307308e+00 +255 5.0740556300071860e-01 -6.6892801585963790e-01 -4.4506165343889975e-01 +336 3.8821455708543523e-01 7.4853146108739210e-01 1.0393955338521590e+00 +74 -8.5185557539809709e-01 5.0099005012093123e-01 6.1187012870886726e-01 +11 -4.8598509694234203e-02 -9.7638648911006976e-01 3.6444261502684167e-01 +106 -8.3362253193144206e-02 -9.2846276284357510e-01 -2.0625632391587234e-01 +342 -1.1850581603543699e+00 -4.6587013939418070e-01 -2.5534356631266192e-01 +366 1.8044603030107276e-01 1.2857436498573065e+00 -4.9002876775305132e-01 +153 5.9355527141792742e-02 8.5309993046714749e-01 1.2601655126485285e+00 +384 -3.3199740732000493e-02 -1.1586262754841152e+00 2.7022536481319620e-01 +444 1.4366137360637837e-01 7.4777392856310121e-01 -1.3874143079892032e-01 +169 -2.2106828869911426e-02 4.3869453276997300e-01 -8.6050040149769946e-01 +312 -9.5175409360636343e-01 -7.9143766981298624e-01 -8.3109524929616485e-01 +131 -1.2661930440833327e-01 4.9560114120296378e-01 1.2481373975929652e-01 +290 4.7988720115251880e-03 4.3307801179133432e-01 7.2537453656012302e-02 +240 -1.4417217340859769e+00 1.4357683004122099e+00 1.4379544254488796e-01 +403 9.8034468727423985e-01 -2.0429774540476020e-01 -1.4454160823908524e-01 +438 1.1944593880989134e+00 2.3483551676455661e+00 1.9984542691081373e+00 +420 1.3486549938776343e-01 -1.0783938772052266e+00 2.4823645088293936e-01 +175 1.6188020186225376e+00 -1.2786027961604105e+00 1.5779664705358573e-01 +305 7.6304434006850930e-01 -1.0609104653684724e+00 -1.3992599279449225e+00 +341 -5.0986549858189378e-01 9.7345649143358179e-02 -5.4583627317992767e-01 +291 1.4937985447982780e+00 1.1345276617898410e-01 1.4735185581275405e+00 +372 2.7438262099508215e-01 2.3642499432513167e-01 2.0103126185436837e-01 +293 -2.0812456222423235e+00 1.2585017395884830e+00 -1.9872753884412903e-01 +461 -1.7366155414350635e+00 6.7563297134023181e-01 -3.0241597324899727e-01 +263 -9.9912758612453856e-01 -1.4606803538340738e+00 -4.8347668759554979e-01 +473 1.5452042518079840e+00 1.3194414166855677e+00 -1.4200655529990689e+00 +166 -1.4143951087621034e-01 -1.1527398628151918e-01 -2.0324403247706951e-01 +132 1.6628716981291343e+00 -2.6751309910688231e-02 -1.1291183234894089e+00 +32 -2.3270952903472897e-01 2.1018074582476372e+00 1.1203402946623044e+00 +475 -1.2604994295453433e+00 -9.5339439518226154e-01 3.3662881048301792e-02 +283 1.2749816341052314e+00 4.7341406662300863e-02 8.5345288522412766e-01 +205 9.6825352209774937e-02 -1.0389613158303228e+00 -5.4505460161674724e-01 +158 8.8743698904591217e-01 1.0689060843560156e+00 6.1104406355038210e-01 +1 5.8273461256327774e-01 4.6658417699512433e-01 7.3964607391058224e-01 +485 4.4170048227791719e-01 -2.8581555293721217e-01 -1.0141724005249320e+00 +378 6.6654429040499424e-02 -1.8224880226392848e+00 1.2128685020610477e+00 +71 -9.1996605782626056e-02 -2.2291664206826806e-01 -1.2402752353304469e+00 +320 -9.5597854323421563e-02 -8.6852053155856812e-01 3.5066557017928385e-01 +481 7.9532304801009490e-01 -9.4180364698072971e-01 1.2495155405965916e-02 +318 -4.1450336396091869e-01 3.4120074122917260e-01 7.3720013366972947e-01 +496 -6.2393347120986375e-01 1.0494054390993381e+00 -1.0590359239552802e+00 +319 -9.5320962685676391e-01 9.2021659866276262e-01 5.5763202369068265e-01 +338 9.5180850251473562e-02 7.4581412234581979e-02 1.6562396473566801e+00 +358 -1.2039319191565336e+00 9.9635011716776112e-01 3.7776599320072252e-01 +225 -2.2878377680357529e-02 5.9393376646738183e-01 -1.7855655501046659e+00 +55 -1.2658412487783444e+00 8.3827650617277571e-01 3.7229167676011687e-01 +362 -1.1190412417889151e+00 -4.1093870066191052e-01 -5.5943417408569930e-02 +36 -1.1944064170110538e+00 5.2834231151049005e-01 -2.5661926163189262e-02 +133 -3.4046853819783990e-01 8.7037698795660379e-01 2.6480748394474063e-01 +412 -8.2433971673189854e-01 -2.4364204997081215e-01 3.2182546651866395e-01 +89 1.2836300411162869e+00 -1.0534639266932924e+00 1.7273414295686953e+00 +38 -5.4018176537409834e-01 1.1189891674084445e+00 -5.4949279328730405e-01 +337 2.0680174457636453e+00 6.8756290663232345e-01 -5.3885707707990127e-01 +233 -1.1580426595635346e-01 1.5352867360847791e+00 1.8920809100075830e-02 +442 -5.2273629379374242e-01 -4.7573534425197805e-01 3.3349171376798270e-01 +143 -6.4456717536444386e-01 -8.2221860127843815e-01 -3.1619033462829965e-01 +194 4.6000888686458724e-01 2.4868203858229221e-01 -1.0844456124091726e+00 +308 7.0412401782623568e-01 1.4705120558853640e-01 -1.6984333842169479e+00 +286 -7.4825969157579242e-01 1.7277684761952672e+00 -4.8658995664543186e-01 +61 -1.4087152482721139e+00 -1.9786675343505181e-01 -8.3049863139435698e-01 +426 -5.9317510584759559e-01 -3.1176204329742879e-01 9.7102624547089234e-01 +450 2.9660411649227686e-01 -1.0106432265344207e+00 -8.0608626908093450e-01 +188 -4.5857896465809017e-01 8.3781782180488956e-02 1.6679261825519407e+00 +94 -2.5105865768429703e-01 -1.0277678550758340e+00 2.0110948522283595e-01 +252 -2.6250057461969262e-01 -8.3779492646801812e-01 -1.2443616941843418e+00 +321 -1.3849227082743394e+00 -7.9961814140752485e-01 -5.2758719721869440e-01 +156 9.7248559724229044e-01 1.4856613149426096e-01 -1.0762319296143268e+00 +167 4.8758255885458768e-01 3.7938735168685944e-01 -8.2720329905212353e-01 +330 4.8147102008722625e-01 -2.9945144880586022e-01 -7.3225876236181275e-01 +195 1.6483881807209144e+00 -1.9598861592898009e-01 -6.2914422221089158e-02 +78 2.3726384124165131e-01 2.7514362192855252e-01 1.7571172900747967e-01 +157 -2.1865090243933563e+00 3.7632441115528098e-01 7.7333806476534650e-01 +373 9.8884980347773899e-01 3.4121263358683873e-01 -3.3626353210018556e-01 +56 -5.1874451216553419e-01 5.0889073330236878e-01 -7.4130187216438104e-01 +315 1.5052362221906064e+00 -6.9840962964633502e-01 -1.5488907100876634e-01 +478 1.1082301092586995e+00 2.9770971389874379e-01 -5.4580262091212584e-01 +109 9.4396405787734605e-01 4.9318782477478235e-01 1.2284569230572757e+00 +357 -1.2371693160029509e+00 4.1376978558912775e-01 3.3529522630256764e-01 +454 -4.4342104600414733e-01 -3.5633346291025164e-01 -2.1131375082322554e-01 +86 -2.6274074185542590e-01 -2.7912975828127135e-01 -3.4564526880694488e-02 +262 -2.0457328043953218e-01 -1.0549970010682790e+00 -8.7569945910877856e-02 +160 1.2508565962389259e-01 -1.1049367732134203e+00 -4.1414673901133031e-01 +168 -5.4833844765552298e-01 9.1122623641564449e-01 -8.1466354261018392e-01 +145 1.9424847461468013e+00 2.4717259671440775e-01 -8.1993106446423478e-02 +400 -7.3927429735196926e-01 9.6278828542903949e-01 9.8355595468926471e-01 +395 -1.7616642510587566e+00 -4.3839255400156163e-01 -4.3538389834393521e-01 +297 -8.1651466743971568e-01 1.9480772762641770e-02 -2.5090574319554337e-01 +207 9.9594630394692474e-01 -5.5333584932915503e-01 -8.1672262386449701e-02 +460 3.8863838706865678e-01 -1.9332061145329088e-01 7.5599739666291188e-01 +44 4.9322334356812642e-01 5.4097595609480897e-01 1.2096517945019982e+00 +377 -2.3588544095100208e-02 4.2843373407529362e-01 -8.1372583759538197e-01 +411 -7.0187880935114388e-01 -8.8403807864596529e-01 3.6139298123719504e-01 +396 -6.1324863673452068e-01 -5.8579142070009704e-01 -1.6980414017487730e+00 +424 -1.4405372913769463e+00 -1.2161267905238037e-01 -7.1275775203655271e-03 +66 -2.2455608800065441e-01 -5.5194985983545303e-02 -2.9031971555487707e-01 +371 2.8693892522161785e-01 -1.3942754264578394e-01 4.1638095135795372e-01 +186 -2.5542578648985415e-01 -2.7435394726950046e-01 1.6931522427410683e+00 +413 5.6007135922818607e-01 1.2189064363493711e-01 -7.5271223366515216e-01 diff --git a/examples/USER/uef/npt_biaxial/in.npt_biaxial b/examples/USER/uef/npt_biaxial/in.npt_biaxial new file mode 100644 index 0000000000000000000000000000000000000000..152054fce652b64b6052e30ec2b73ab7e3f92278 --- /dev/null +++ b/examples/USER/uef/npt_biaxial/in.npt_biaxial @@ -0,0 +1,31 @@ +# biaxial NPT deformation of WCA fluid + +units lj +atom_style atomic + + +pair_style lj/cut 1.122562 +read_data data.wca +pair_coeff 1 1 1.0 1.0 +pair_modify shift yes + +neighbor 0.5 bin +neigh_modify delay 0 + +change_box all triclinic + +# these commads show the different methods that may be used to impose +# a constant stress through isotropic or anisotropic coupling +fix 1 all npt/uef temp 0.722 0.722 0.5 iso 10 10 5 erate 0.5 0.5 ext z +#fix 1 all npt/uef temp 0.722 0.722 0.5 z 10 10 5 erate 0.5 0.5 ext xyz + +fix 2 all momentum 100 linear 1 1 1 + +#dump 1 all atom 25 dump.lammpstrj + +#dump 2 all cfg/uef 25 dump.*.cfg mass type xs ys zs + +thermo_style custom step c_1_press[1] c_1_press[2] c_1_press[3] + +thermo 50 +run 10000 diff --git a/examples/USER/uef/npt_biaxial/log.30Jul16.npt_biaxial.g++.1 b/examples/USER/uef/npt_biaxial/log.30Jul16.npt_biaxial.g++.1 new file mode 100644 index 0000000000000000000000000000000000000000..65f0184d139eb4658c927e1ad362cf3856338475 --- /dev/null +++ b/examples/USER/uef/npt_biaxial/log.30Jul16.npt_biaxial.g++.1 @@ -0,0 +1,276 @@ +LAMMPS (30 Jul 2016) +# biaxial NPT deformation of WCA fluid + +units lj +atom_style atomic + + +pair_style lj/cut 1.122562 +read_data data.wca + orthogonal box = (0 0 0) to (8.39798 8.39798 8.39798) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities +pair_coeff 1 1 1.0 1.0 +pair_modify shift yes + +neighbor 0.5 bin +neigh_modify delay 0 + +change_box all triclinic + triclinic box = (0 0 0) to (8.39798 8.39798 8.39798) with tilt (0 0 0) + +# these commads show the different methods that may be used to impose +# a constant stress through isotropic or anisotropic coupling +fix 1 all npt/uef temp 0.722 0.722 0.5 iso 10 10 5 erate 0.5 0.5 ext z +#fix 1 all npt/uef temp 0.722 0.722 0.5 z 10 10 5 erate 0.5 0.5 ext xyz + +fix 2 all momentum 100 linear 1 1 1 + +#dump 1 all atom 25 dump.lammpstrj + +#dump 2 all cfg/uef 25 dump.*.cfg mass type xs ys zs + +thermo_style custom step c_1_press[1] c_1_press[2] c_1_press[3] + +thermo 50 +run 10000 +Neighbor list info ... + 1 neighbor list requests + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 1.62256 + ghost atom cutoff = 1.62256 + binsize = 0.811281 -> bins = 11 11 11 +Memory usage per processor = 2.40217 Mbytes +Step 1_press[ 1_press[ 1_press[ + 0 6.3937851 7.0436438 6.4461087 + 50 7.9020345 7.303289 14.733929 + 100 8.3214325 8.385843 13.166247 + 150 5.7168419 5.6083988 9.7224198 + 200 3.8875348 4.0840705 7.9912973 + 250 4.2933724 4.2410519 7.7200953 + 300 4.5452314 4.2434949 8.6709832 + 350 5.446489 5.6166962 11.300536 + 400 6.0682558 5.7787878 12.106852 + 450 5.3884296 5.5066688 9.9100012 + 500 4.8046418 4.7115986 9.9769201 + 550 4.9043933 4.6240966 9.319336 + 600 4.6843238 4.9571246 9.5325487 + 650 5.1952989 5.195648 9.6187047 + 700 5.4163364 5.2938289 10.136655 + 750 5.6723178 5.0670261 11.415221 + 800 5.9379901 5.6402916 10.815209 + 850 5.0695389 5.3021432 10.742859 + 900 4.6498962 4.7111912 9.8453523 + 950 4.4811641 5.170132 9.421765 + 1000 4.7501483 4.2420772 9.3510803 + 1050 4.5973379 5.2046799 9.8632975 + 1100 4.7879562 4.9051316 9.8658626 + 1150 5.0528771 5.5048545 10.110913 + 1200 4.9926563 5.2482081 9.9610863 + 1250 4.8476232 4.8498859 9.5752989 + 1300 5.2932038 5.0594534 10.869545 + 1350 5.4720421 5.0830442 10.69386 + 1400 4.8175566 4.9863651 10.041898 + 1450 4.6307145 4.5615459 9.231299 + 1500 5.0296259 4.5433558 8.7180513 + 1550 4.8708444 5.1601014 10.256791 + 1600 5.5098593 5.316773 10.224386 + 1650 5.5055907 5.0516814 10.272037 + 1700 4.6965552 5.2436628 9.8272905 + 1750 5.0212307 4.740601 8.9738802 + 1800 4.7756351 5.199734 9.9929449 + 1850 4.7107092 5.177203 10.580427 + 1900 5.0935608 4.5286844 9.3036832 + 1950 4.8035855 4.894359 9.4423987 + 2000 4.5643937 4.7480477 9.4384251 + 2050 4.9314701 4.990414 10.151815 + 2100 5.9828824 5.8188026 12.262691 + 2150 5.5337303 5.4598468 10.136112 + 2200 4.892172 4.8699674 9.1629905 + 2250 4.5680591 4.5740533 9.5633545 + 2300 5.0023535 4.3948659 8.9645774 + 2350 5.2533056 4.9803884 10.255653 + 2400 5.3330196 5.3888322 10.021617 + 2450 5.2095527 4.8765336 10.135381 + 2500 5.221153 5.2974568 10.2493 + 2550 5.385331 5.0801192 10.490479 + 2600 5.3274988 5.0253548 10.147587 + 2650 4.718677 5.2710337 9.7549521 + 2700 4.5811521 4.6083971 8.1923164 + 2750 4.4743752 4.3319737 8.8690805 + 2800 5.0215013 5.2262961 9.8627954 + 2850 6.1005107 5.5994942 11.170661 + 2900 5.9673524 5.362124 10.401699 + 2950 5.5400849 5.7523993 10.292536 + 3000 4.9202636 5.1210431 10.125839 + 3050 4.5286487 5.3586164 9.8634322 + 3100 4.5719961 5.1615414 9.8027972 + 3150 5.4091919 4.8581943 9.96938 + 3200 5.522125 5.3564838 9.7638407 + 3250 4.9019062 5.2514758 9.2993079 + 3300 5.2375918 5.1439012 9.4313575 + 3350 4.750235 4.8692016 10.54193 + 3400 5.5793211 5.4184157 11.021389 + 3450 4.9022614 5.3166498 9.4629659 + 3500 4.6348617 4.4650979 9.0665548 + 3550 4.7922405 4.8961269 10.255446 + 3600 4.8914457 5.1158894 9.4736084 + 3650 5.062771 4.6725475 10.263484 + 3700 5.4842823 5.7793971 10.342915 + 3750 5.3136012 5.063065 10.398307 + 3800 4.9372149 4.9270414 9.5304748 + 3850 5.2144752 5.1716455 9.7575725 + 3900 5.0892665 5.1697057 9.918052 + 3950 5.1124507 5.354702 9.791366 + 4000 5.1255084 5.1143653 10.913101 + 4050 5.1891698 4.9913681 9.6871728 + 4100 4.7663368 4.2435014 8.3815668 + 4150 4.8060033 4.3415868 9.6553386 + 4200 4.8548303 4.8006768 9.5995801 + 4250 5.0976366 5.2683175 10.386444 + 4300 5.8921937 5.5134696 10.788143 + 4350 5.8323871 5.5255869 11.199128 + 4400 5.2464655 5.0005905 10.311055 + 4450 4.9264849 5.2499854 10.26702 + 4500 4.4431895 4.536981 8.7489096 + 4550 4.5180914 4.2080277 8.6525529 + 4600 5.1782188 5.1224059 10.683341 + 4650 5.4156233 4.8714464 10.473939 + 4700 5.3107669 5.224614 10.569391 + 4750 4.9538022 5.2509475 10.288918 + 4800 4.6976945 4.8107142 9.8299772 + 4850 5.1227936 5.0737571 10.440452 + 4900 4.7580514 4.6375995 9.1971008 + 4950 5.0647601 4.6470735 9.583131 + 5000 5.196231 5.7531491 10.409807 + 5050 5.6691323 5.7163652 12.335701 + 5100 5.3603738 5.4887106 10.961712 + 5150 4.455028 4.6494465 9.8096968 + 5200 4.7596912 4.4804896 9.3762885 + 5250 5.3144927 5.0113772 9.553101 + 5300 5.3445266 4.8262035 9.1220802 + 5350 5.1540657 5.5982676 10.765178 + 5400 5.1773418 5.2684381 10.452351 + 5450 4.8946859 5.3283747 9.8015564 + 5500 5.2009608 4.7183522 9.4558009 + 5550 5.4158589 5.5005458 10.539505 + 5600 4.7196831 5.4181991 9.6439249 + 5650 4.8333571 4.8601728 8.9350189 + 5700 5.4395698 4.9730096 10.669681 + 5750 5.2947443 5.6973259 10.020539 + 5800 5.4391993 5.5255143 10.264969 + 5850 4.9921388 5.2643827 10.217028 + 5900 5.0048643 4.7952641 8.9718929 + 5950 5.1843818 4.5987295 9.6858944 + 6000 5.0343993 4.946933 9.7436708 + 6050 4.6202714 5.3502658 10.752915 + 6100 5.6914422 5.3621964 10.281827 + 6150 5.1928763 5.9652686 10.923881 + 6200 5.0030409 5.2013891 10.056308 + 6250 4.9699876 5.2363753 9.9964211 + 6300 4.9129606 4.4558458 9.0419952 + 6350 4.6623958 4.4078264 8.528649 + 6400 4.9811441 5.1183207 10.261751 + 6450 5.3644017 5.5153937 10.401295 + 6500 5.6674981 5.7427566 11.928777 + 6550 5.1622364 5.3212928 10.067198 + 6600 4.5954278 5.1645397 10.16724 + 6650 4.9192712 5.0413326 9.95656 + 6700 4.6179845 4.5656214 9.3798952 + 6750 4.7287495 4.5071148 8.7890116 + 6800 4.8600442 4.8083512 10.245595 + 6850 5.0515531 5.1609272 10.553855 + 6900 5.1159742 5.1359869 10.594699 + 6950 4.8908884 5.0592418 9.5698704 + 7000 4.7654136 4.7530776 8.9439321 + 7050 4.779293 4.7534957 9.7244349 + 7100 5.2265831 5.6869073 10.32717 + 7150 5.4019177 5.15174 10.457567 + 7200 4.9817102 5.0596098 10.337574 + 7250 5.1836654 5.6065238 10.723108 + 7300 4.2916569 4.457143 8.5419099 + 7350 4.3906104 4.5439294 9.0805415 + 7400 4.998572 5.3386063 10.491418 + 7450 5.1109022 5.0506801 10.636116 + 7500 5.0248381 5.019932 10.217023 + 7550 5.0109265 5.1438717 9.9032426 + 7600 4.6628614 4.6204146 8.9459669 + 7650 4.8930717 5.0650009 10.049331 + 7700 4.9373454 5.6265835 10.210644 + 7750 5.5001067 5.3133253 10.667995 + 7800 5.0816102 5.0125753 10.591986 + 7850 4.9638046 5.1969015 9.9728333 + 7900 4.8438207 4.9217213 8.9978809 + 7950 4.7318805 4.6248537 8.6806596 + 8000 5.2808543 5.2892613 10.932535 + 8050 5.9609722 5.87087 10.47602 + 8100 5.2190231 5.6693244 11.244536 + 8150 5.3481127 5.2849903 10.222845 + 8200 4.7833053 4.7404657 9.2034474 + 8250 4.5461994 4.510467 10.294452 + 8300 4.6025175 4.8332817 8.7967546 + 8350 5.0389897 5.6642908 10.243402 + 8400 4.8414338 4.8925143 9.3653631 + 8450 5.5087429 4.7830361 10.831666 + 8500 5.2678146 5.1697789 9.9105782 + 8550 5.1211843 4.9097801 9.4165956 + 8600 5.8239149 5.0821022 10.803261 + 8650 5.3620154 5.5831747 11.16202 + 8700 5.1625813 4.8791404 10.537681 + 8750 4.5622461 5.0157549 10.013227 + 8800 4.4051517 5.0224553 9.6364273 + 8850 4.1711629 4.635617 8.5470244 + 8900 4.7049907 5.2458435 10.100728 + 8950 4.8568883 5.2360772 9.2306469 + 9000 5.0091899 5.2203574 10.718541 + 9050 5.1037824 4.9022451 10.24271 + 9100 5.0789015 4.9331454 9.173614 + 9150 5.3865455 5.3427553 11.40199 + 9200 5.5089482 5.9423232 10.976063 + 9250 5.1353552 5.0650262 10.040607 + 9300 4.6761948 4.9155175 9.6413722 + 9350 4.4780834 4.3934708 8.7049819 + 9400 4.2561799 4.7906324 9.046134 + 9450 5.6162819 5.2881846 9.9040868 + 9500 5.7554547 5.6111262 10.23849 + 9550 5.4230462 5.5656045 10.908006 + 9600 5.5045685 4.9818892 9.8929535 + 9650 5.0541481 5.0183351 9.5226021 + 9700 4.9712829 5.2395398 9.9996693 + 9750 5.0960017 5.4419775 10.914719 + 9800 5.0790688 5.6378474 10.00789 + 9850 4.9661747 5.114502 9.4585052 + 9900 5.0133498 4.7456254 9.4572653 + 9950 5.3318846 4.6643122 10.096292 + 10000 5.2227687 4.8924305 9.5894615 +Loop time of 4.42114 on 1 procs for 10000 steps with 500 atoms + +Performance: 977122.661 tau/day, 2261.858 timesteps/s +99.9% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.72321 | 0.72321 | 0.72321 | 0.0 | 16.36 +Neigh | 2.6161 | 2.6161 | 2.6161 | 0.0 | 59.17 +Comm | 0.30217 | 0.30217 | 0.30217 | 0.0 | 6.83 +Output | 0.0034378 | 0.0034378 | 0.0034378 | 0.0 | 0.08 +Modify | 0.67004 | 0.67004 | 0.67004 | 0.0 | 15.16 +Other | | 0.1062 | | | 2.40 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 905 ave 905 max 905 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 3340 ave 3340 max 3340 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 3340 +Ave neighs/atom = 6.68 +Neighbor list builds = 4580 +Dangerous builds = 0 +Total wall time: 0:00:04 diff --git a/examples/USER/uef/npt_biaxial/log.30Jul16.npt_biaxial.g++.4 b/examples/USER/uef/npt_biaxial/log.30Jul16.npt_biaxial.g++.4 new file mode 100644 index 0000000000000000000000000000000000000000..4ff3551605a770c822f982caf4b1b437a1208571 --- /dev/null +++ b/examples/USER/uef/npt_biaxial/log.30Jul16.npt_biaxial.g++.4 @@ -0,0 +1,276 @@ +LAMMPS (30 Jul 2016) +# biaxial NPT deformation of WCA fluid + +units lj +atom_style atomic + + +pair_style lj/cut 1.122562 +read_data data.wca + orthogonal box = (0 0 0) to (8.39798 8.39798 8.39798) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities +pair_coeff 1 1 1.0 1.0 +pair_modify shift yes + +neighbor 0.5 bin +neigh_modify delay 0 + +change_box all triclinic + triclinic box = (0 0 0) to (8.39798 8.39798 8.39798) with tilt (0 0 0) + +# these commads show the different methods that may be used to impose +# a constant stress through isotropic or anisotropic coupling +fix 1 all npt/uef temp 0.722 0.722 0.5 iso 10 10 5 erate 0.5 0.5 ext z +#fix 1 all npt/uef temp 0.722 0.722 0.5 z 10 10 5 erate 0.5 0.5 ext xyz + +fix 2 all momentum 100 linear 1 1 1 + +#dump 1 all atom 25 dump.lammpstrj + +#dump 2 all cfg/uef 25 dump.*.cfg mass type xs ys zs + +thermo_style custom step c_1_press[1] c_1_press[2] c_1_press[3] + +thermo 50 +run 10000 +Neighbor list info ... + 1 neighbor list requests + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 1.62256 + ghost atom cutoff = 1.62256 + binsize = 0.811281 -> bins = 11 11 11 +Memory usage per processor = 2.38201 Mbytes +Step 1_press[ 1_press[ 1_press[ + 0 6.3937851 7.0436438 6.4461087 + 50 7.9020345 7.303289 14.733929 + 100 8.3214325 8.385843 13.166247 + 150 5.7168419 5.6083988 9.7224198 + 200 3.8875348 4.0840705 7.9912973 + 250 4.2933724 4.2410519 7.7200953 + 300 4.5452314 4.2434949 8.6709832 + 350 5.446489 5.6166962 11.300536 + 400 6.0682558 5.7787878 12.106852 + 450 5.3884296 5.5066688 9.9100012 + 500 4.8046418 4.7115986 9.9769201 + 550 4.9043933 4.6240966 9.319336 + 600 4.6843238 4.9571246 9.5325487 + 650 5.1952989 5.195648 9.6187047 + 700 5.4163364 5.2938289 10.136655 + 750 5.6723178 5.0670261 11.415221 + 800 5.9379901 5.6402916 10.815209 + 850 5.0695389 5.3021432 10.742859 + 900 4.6498961 4.7111912 9.8453525 + 950 4.4811637 5.170132 9.4217644 + 1000 4.7501491 4.2420769 9.3510789 + 1050 4.5973375 5.2046786 9.8633021 + 1100 4.7879517 4.905134 9.8658575 + 1150 5.0528775 5.5048673 10.110907 + 1200 4.9926837 5.2482072 9.961051 + 1250 4.8475661 4.8499052 9.5753719 + 1300 5.2929874 5.0593404 10.869345 + 1350 5.4722108 5.083063 10.693408 + 1400 4.816304 4.9851244 10.041255 + 1450 4.6280905 4.5646059 9.2298768 + 1500 5.01985 4.5471327 8.721625 + 1550 4.8741077 5.1549887 10.256565 + 1600 5.4916921 5.3197646 10.281538 + 1650 5.4772243 5.1837045 9.9982297 + 1700 4.9419503 5.2869766 9.5825456 + 1750 5.0000465 4.6358961 8.8873809 + 1800 5.0008968 4.9755404 10.274347 + 1850 5.3911106 5.0602442 10.252838 + 1900 5.6306791 5.5982927 11.287727 + 1950 5.0117663 4.9037147 9.9079668 + 2000 4.9080829 4.8206128 9.2645313 + 2050 4.7794302 4.5942332 9.22621 + 2100 5.1197536 4.884078 9.9557557 + 2150 5.5674448 4.9602998 10.825168 + 2200 5.9993278 5.484917 11.201052 + 2250 5.619781 5.2475017 10.382149 + 2300 4.7213112 4.5460993 10.254176 + 2350 4.4310098 4.6363048 8.2696199 + 2400 4.2798177 4.1485611 8.2037599 + 2450 5.0414399 5.2572888 10.126969 + 2500 5.2807077 5.4633007 10.424033 + 2550 5.4538601 5.3268172 10.06153 + 2600 4.9750473 5.2268468 10.433373 + 2650 4.8397032 5.2258654 9.8686538 + 2700 4.8943282 4.7637421 9.8715146 + 2750 4.8870682 4.7334316 9.2096451 + 2800 4.7611053 4.9820018 9.0797655 + 2850 4.826047 5.2478652 10.549013 + 2900 5.5999506 5.0160442 9.6169413 + 2950 5.6210454 5.1519961 10.23173 + 3000 5.2132243 5.1449194 9.9778889 + 3050 5.651798 5.5919186 10.772823 + 3100 4.8453492 4.6559497 9.175617 + 3150 4.359467 4.9901271 8.512659 + 3200 4.5724772 4.8788065 9.2580198 + 3250 5.3195893 5.6518901 10.562311 + 3300 5.4571458 5.9778537 11.804991 + 3350 5.1322763 5.280149 10.894715 + 3400 4.9393514 4.9051844 9.3048468 + 3450 4.6741698 4.6317669 9.4965959 + 3500 4.8634066 4.9618835 8.926419 + 3550 4.7096981 4.4196734 9.5607265 + 3600 5.1871839 5.3427606 9.9467134 + 3650 5.7619975 5.2486309 10.359674 + 3700 5.2563068 5.4591612 10.360825 + 3750 5.2492743 5.4861677 9.7648858 + 3800 5.0335744 5.2240642 9.6668438 + 3850 5.1003253 5.0865548 11.111281 + 3900 5.2978019 5.2126205 10.581896 + 3950 5.0067291 5.2645911 10.750446 + 4000 4.6513682 4.7407991 9.3959165 + 4050 4.1903728 4.4021987 8.8451881 + 4100 5.0089655 4.4961608 9.7363416 + 4150 5.1557684 5.6110293 10.804015 + 4200 5.2607824 5.3663361 10.663617 + 4250 5.0134036 5.1164765 9.3320261 + 4300 4.2919496 4.6118896 9.2176556 + 4350 4.9118467 4.9766595 9.8989104 + 4400 5.7694762 5.2410849 10.660891 + 4450 5.3793656 5.4714178 10.784611 + 4500 5.187077 5.0952514 9.6404449 + 4550 4.9522826 4.5959954 10.30975 + 4600 4.9512246 5.0305627 10.295169 + 4650 5.8017637 5.3485687 10.411051 + 4700 5.2499784 4.8217382 10.077816 + 4750 4.9961796 4.9148313 9.4660475 + 4800 4.8958835 4.6546838 9.1730325 + 4850 4.7408482 5.1862514 9.9399226 + 4900 4.999383 4.9513486 9.5506941 + 4950 5.0375134 4.63474 10.325618 + 5000 5.0274884 5.391675 9.592851 + 5050 5.3817822 5.5141892 11.43286 + 5100 5.533224 5.1489534 10.56325 + 5150 4.4884587 4.8979144 9.7439562 + 5200 4.7352575 4.2854079 8.8328248 + 5250 4.6347427 4.7579757 9.5316726 + 5300 4.9765192 5.1378784 9.7376039 + 5350 5.1899675 4.9469798 10.699202 + 5400 5.0178189 5.47536 9.707559 + 5450 4.9537295 5.1651951 9.7430567 + 5500 4.8448459 4.6800231 9.297621 + 5550 5.1703386 4.865903 10.090954 + 5600 5.6293349 5.4332687 10.047955 + 5650 5.2729245 6.180173 10.259202 + 5700 5.1034054 5.2082315 10.031079 + 5750 5.0982009 5.0158875 10.3517 + 5800 4.8139573 4.8454398 10.001093 + 5850 5.3237843 4.9860148 10.493724 + 5900 4.421652 4.7147453 10.30137 + 5950 5.3475173 4.8489279 9.7495241 + 6000 5.013939 4.796874 9.7433063 + 6050 5.1111778 5.2773346 10.245638 + 6100 5.1484609 5.2230939 9.9800589 + 6150 5.0101213 5.0702323 9.7021038 + 6200 4.5881964 5.2635287 9.3903355 + 6250 5.5340791 5.5956851 10.809705 + 6300 5.3121762 5.3679934 9.4683653 + 6350 5.072589 5.0111289 10.494452 + 6400 5.3134876 5.3779245 11.439347 + 6450 4.9930408 5.3215491 10.287925 + 6500 4.6925854 4.4527123 9.3141266 + 6550 4.5127115 4.5276223 9.2970101 + 6600 4.6857945 5.0039986 9.8782575 + 6650 5.4210348 4.6775837 10.404812 + 6700 5.416291 5.1705872 10.935776 + 6750 5.2396825 5.0306589 10.14922 + 6800 5.3579349 4.9442072 10.510841 + 6850 4.8287972 4.4930847 9.4697502 + 6900 4.9688784 4.5977364 10.004321 + 6950 4.7853293 4.5578984 9.0727469 + 7000 5.0589506 4.9662362 11.04237 + 7050 5.2657677 5.3989373 10.712811 + 7100 5.5373555 5.6700228 10.099215 + 7150 4.7085526 4.4207863 9.417028 + 7200 4.7480934 4.8575585 9.970864 + 7250 5.2732588 5.211703 9.8573725 + 7300 5.0152654 5.5514349 11.104278 + 7350 4.9255785 5.3533123 10.69476 + 7400 5.1041241 5.0597338 9.5918592 + 7450 4.7333067 4.584844 10.820426 + 7500 4.9157751 5.0274623 10.706391 + 7550 4.8231717 5.2251684 9.7721097 + 7600 4.5115685 4.6809903 9.1230191 + 7650 4.76928 5.0869557 9.2881957 + 7700 5.1014383 5.4733369 9.9024386 + 7750 5.7812792 5.6404429 10.895814 + 7800 5.451651 5.4137204 10.471661 + 7850 4.7982757 5.2043999 10.046712 + 7900 4.4490306 4.546108 8.3934233 + 7950 4.3147055 4.489834 8.8833017 + 8000 5.0558378 5.1022203 11.21385 + 8050 6.0715673 5.9289687 12.007167 + 8100 5.4463621 5.8686057 9.7475724 + 8150 4.6295786 4.5658519 8.9353979 + 8200 4.4109788 4.4122705 8.8574801 + 8250 4.9903375 5.2807872 10.024069 + 8300 5.2930602 5.7480682 10.33242 + 8350 5.6166755 5.3279586 10.761278 + 8400 5.2344331 5.3991078 10.261601 + 8450 4.9395736 4.8421048 10.544976 + 8500 4.8692729 4.4538669 10.38133 + 8550 4.7746965 4.5959252 10.413873 + 8600 4.4344376 4.9176179 9.0368016 + 8650 5.0230802 4.7795825 8.5121429 + 8700 4.9279145 4.8844196 10.145405 + 8750 5.343116 5.7462499 11.191805 + 8800 5.4073851 5.1952022 9.6534892 + 8850 5.6085471 5.1332845 10.28282 + 8900 4.9077946 5.1446696 9.236557 + 8950 4.9416647 5.2071136 10.106251 + 9000 5.4201564 5.3733264 11.081109 + 9050 5.9648951 5.5501112 12.621681 + 9100 4.8947991 5.2187898 10.470022 + 9150 4.48197 4.1036268 8.4201904 + 9200 4.3946543 4.3973715 8.5340163 + 9250 5.3021965 5.2717867 9.2560849 + 9300 5.1768568 5.8272523 10.232503 + 9350 5.7291082 5.7641611 11.622836 + 9400 5.5971415 6.0957826 11.948662 + 9450 4.6317008 4.8550521 9.7699372 + 9500 4.3364192 4.4197985 8.8085022 + 9550 4.4961662 4.5930997 9.6064493 + 9600 4.901858 5.3789866 10.044551 + 9650 5.2916208 4.9071387 9.9083075 + 9700 4.8995154 4.78658 9.3871144 + 9750 5.5045136 5.3070515 10.969147 + 9800 5.2729372 6.0714054 11.027892 + 9850 4.8794625 5.2788176 10.100819 + 9900 4.6173961 4.6918339 9.2090718 + 9950 4.7478539 4.6911854 8.6831286 + 10000 4.9331146 5.3771408 11.489778 +Loop time of 2.62782 on 4 procs for 10000 steps with 500 atoms + +Performance: 1643945.149 tau/day, 3805.429 timesteps/s +99.9% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.29968 | 0.30667 | 0.31341 | 1.2 | 11.67 +Neigh | 1.0173 | 1.0395 | 1.0668 | 2.1 | 39.56 +Comm | 0.55804 | 0.59161 | 0.62132 | 3.5 | 22.51 +Output | 0.0028653 | 0.0035743 | 0.0056112 | 2.0 | 0.14 +Modify | 0.5692 | 0.5732 | 0.57625 | 0.4 | 21.81 +Other | | 0.1132 | | | 4.31 + +Nlocal: 125 ave 130 max 121 min +Histogram: 1 1 0 0 0 0 1 0 0 1 +Nghost: 452.25 ave 455 max 449 min +Histogram: 1 0 0 0 0 1 1 0 0 1 +Neighs: 837 ave 882 max 804 min +Histogram: 2 0 0 0 0 0 1 0 0 1 + +Total # of neighbors = 3348 +Ave neighs/atom = 6.696 +Neighbor list builds = 4598 +Dangerous builds = 0 +Total wall time: 0:00:02 diff --git a/examples/USER/uef/nvt_uniaxial/data.wca b/examples/USER/uef/nvt_uniaxial/data.wca new file mode 100644 index 0000000000000000000000000000000000000000..889ba4d2f2a8d2cb3892bda144544f23140ccc03 --- /dev/null +++ b/examples/USER/uef/nvt_uniaxial/data.wca @@ -0,0 +1,1022 @@ +LAMMPS data file via write_data, version 14 May 2016, timestep = 400000 + +500 atoms +1 atom types + +0.0000000000000000e+00 8.3979809569125372e+00 xlo xhi +0.0000000000000000e+00 8.3979809569125372e+00 ylo yhi +0.0000000000000000e+00 8.3979809569125372e+00 zlo zhi + +Masses + +1 1 + +Pair Coeffs # lj/cut + +1 1 1 + +Atoms # atomic + +7 1 2.4137737201272674e-01 2.0017433398687118e-01 3.6157393311703534e-02 2 1 2 +398 1 1.6739594898193126e+00 3.0313452824803544e-01 5.7986723161362197e-01 -3 0 1 +173 1 6.1370793327804556e+00 4.4978954867119525e-01 3.6568951377817088e-01 -4 1 0 +462 1 7.8754716784931862e+00 5.2908038473333074e-01 7.9185633743762940e-01 1 1 -2 +383 1 6.5373096080170212e-01 1.5337525983981986e+00 6.3208419126059423e-01 2 0 1 +288 1 1.9354124990672374e+00 1.3318105136786291e+00 3.6211635210084403e-01 -1 1 0 +303 1 2.9661308460819318e+00 1.1444058564802859e+00 6.5604777151148241e-01 -2 2 1 +491 1 7.1514675802966758e+00 1.3588685826107376e+00 1.2875068928885325e-01 -1 0 0 +187 1 3.0670386025081497e-01 2.4850915964494620e+00 7.0944157374329464e-02 0 -1 0 +163 1 1.2805212773629451e+00 2.4034621328433090e+00 2.0184086197146742e-01 0 1 -1 +345 1 2.5952244948945173e+00 2.3405536448220743e+00 3.0019149048630317e-01 -3 2 1 +447 1 3.9059163101716741e+00 1.6849179478858272e+00 6.0306488750926446e-01 -2 3 -4 +108 1 4.9215629854759335e+00 2.5174843149522088e+00 6.2779912940916158e-02 1 0 -1 +427 1 6.3978861821382305e+00 1.9201774263431104e+00 4.3981049730412797e-01 -1 -2 -3 +96 1 7.4061541304605534e+00 2.4828308207907996e+00 2.4705543772216432e-01 0 -3 2 +494 1 8.0759482343563711e+00 1.6914241739458744e+00 6.8482420189075921e-01 -3 1 2 +360 1 3.1886448226656765e+00 3.1126224743956139e+00 5.4052217066940123e-01 1 1 -2 +179 1 4.2399500260508116e+00 2.8640916432630559e+00 7.5278462735962870e-01 -1 1 1 +136 1 6.2603021059339365e+00 3.2638426060411403e+00 9.9163685662983045e-02 -2 0 3 +311 1 8.0699058291845773e+00 3.1228722160017734e+00 7.5458759573094458e-01 -3 -3 3 +242 1 8.1363443818268044e-02 3.8061968817045986e+00 5.4644298839992535e-02 1 1 1 +451 1 1.9291602479953753e+00 3.5896469823727863e+00 2.3008537852985023e-01 -1 0 0 +118 1 5.3566912079946780e+00 3.5234509548370374e+00 6.7801317822012042e-01 1 -3 -1 +200 1 6.7588369512940338e-01 6.1719413314115790e-01 9.9275606042642373e-01 -1 2 3 +23 1 2.1873327028525060e+00 4.2754803645009956e-02 1.4143560341384132e+00 -3 -1 0 +30 1 3.9592898204338112e+00 6.8093268022015185e-01 1.2987004742604558e+00 -1 -2 -2 +26 1 5.1175076813830467e+00 5.1869033157649591e-01 9.5797839381311178e-01 0 1 2 +452 1 6.5582763761917411e+00 3.4514602671261341e-01 1.2368598815410630e+00 -2 0 -2 +439 1 8.3865135868155445e+00 1.4825845267600596e-01 1.6737363681796917e+00 -2 3 1 +492 1 1.6645816560197648e+00 9.7557398318995125e-01 1.3973497820249918e+00 -2 3 1 +287 1 2.8845951500519784e+00 9.2974386224238703e-01 1.6104516406361071e+00 2 -1 2 +87 1 5.9282888423658395e+00 1.2716232081523247e+00 1.1744299163086194e+00 -1 2 -1 +191 1 7.0465887128985001e+00 1.3447129135151838e+00 1.1378718594147066e+00 -1 2 0 +316 1 6.6785856436835267e-01 2.4243200282222617e+00 1.1253836626025919e+00 0 1 0 +176 1 1.8165460632802826e+00 2.1437252128100086e+00 1.0868234266569741e+00 1 1 1 +244 1 3.5041229236927576e+00 2.3924032537771125e+00 1.3551249499971583e+00 -3 1 4 +463 1 4.9238071200835165e+00 1.7488964460038467e+00 8.7393010597649756e-01 -2 2 1 +101 1 4.7502017837518187e+00 2.5070270251466997e+00 1.6042073679153410e+00 -3 0 -2 +456 1 6.7262574842655534e+00 2.1937608587635533e+00 1.5819520420856528e+00 0 2 3 +90 1 7.8106680805872131e+00 2.3465270292028992e+00 1.4066520475037838e+00 0 -4 1 +457 1 2.2543678933961773e+00 3.1652213402916889e+00 1.1451988834668292e+00 -1 0 0 +344 1 5.9751963550424136e+00 2.8740523385222234e+00 1.2530570351392452e+00 0 1 -1 +399 1 8.2525481582297566e-01 3.4796551803028120e+00 1.0452539946382762e+00 1 -1 -1 +472 1 2.5500022667255768e+00 4.1144011701979659e+00 1.1937493716055980e+00 0 1 2 +364 1 3.2074279852156709e+00 3.3909867375667604e+00 1.5492265188845586e+00 -1 0 0 +333 1 4.2063776055408209e+00 3.7436012461483292e+00 1.2983951160694676e+00 -1 1 1 +223 1 6.0720407506223024e+00 3.9437056464141231e+00 1.5634726007362729e+00 0 0 1 +277 1 6.8850289844945918e+00 3.5744109988378070e+00 1.1843729982426427e+00 2 0 0 +487 1 8.0236797280148657e+00 4.0759691449476652e+00 1.1816920447826709e+00 -1 0 5 +202 1 1.1425010515906946e+00 1.1629395296284512e-02 2.5086432758529211e+00 -1 -2 0 +139 1 2.3147555111337756e+00 1.8665688332261610e-01 2.4220734387693037e+00 -5 0 1 +218 1 3.5367098631556342e+00 6.2760250051756761e-01 2.4478818232869410e+00 1 0 -2 +10 1 4.3729774450168737e+00 1.6632191047636544e-01 2.1079853667170236e+00 -2 -1 -2 +64 1 5.7303792911825742e+00 2.9006680684615282e-01 1.9605629224377070e+00 -2 1 2 +40 1 6.5824557178778531e-01 8.5028950299011019e-01 2.1496168105059708e+00 2 1 1 +328 1 1.5589817713112594e-01 1.6225523918451032e+00 1.7310231111691350e+00 3 0 0 +292 1 2.1314993621742819e+00 1.2260233186264009e+00 2.3652294967955245e+00 0 0 -1 +245 1 4.6666032401598603e+00 1.5042368206958292e+00 1.9142905720694421e+00 -3 1 -1 +148 1 6.7720428171922631e+00 8.7008110148972428e-01 2.0934267451930806e+00 0 0 1 +435 1 7.7341388550057273e+00 9.1983544373491155e-01 1.8223856537522831e+00 -2 -1 1 +301 1 2.9295611364078922e-01 2.4942786265027763e+00 2.2355337509297120e+00 -2 -3 -2 +476 1 1.3648021789963285e+00 1.8605609454926342e+00 2.0851101905225424e+00 1 0 -1 +310 1 2.6428836469132526e+00 2.1636738846129742e+00 1.7827293416008847e+00 3 2 0 +137 1 3.6368685754799719e+00 1.7198335009724290e+00 2.1014306554853008e+00 1 -1 1 +434 1 5.6400362255303138e+00 2.0264029757942144e+00 1.7648993119896872e+00 0 -1 0 +184 1 7.6228520959849160e+00 2.1704001606029473e+00 2.4690779972373509e+00 0 1 -1 +5 1 1.5547914352159820e+00 3.0246432147284117e+00 1.9341058666944422e+00 5 1 -2 +41 1 3.5394530649909939e+00 2.8672493763709368e+00 2.3721754433370239e+00 0 0 0 +410 1 5.2622202291807252e+00 3.3532222678989076e+00 2.0249715425869179e+00 2 1 1 +418 1 6.2986243250817040e+00 2.9042203242504363e+00 2.3450580832445986e+00 -1 2 0 +34 1 6.5845359986575269e-01 3.5330771386953552e+00 2.1708302646106170e+00 -2 3 1 +67 1 2.2321109286615104e+00 3.8391986294826608e+00 2.3598318070524229e+00 1 -1 0 +390 1 4.4001972293445766e+00 3.7784400898230768e+00 2.3530190506208175e+00 1 2 -1 +125 1 6.8584035481270371e+00 3.7859398002695177e+00 2.2262509649550242e+00 -3 1 3 +105 1 8.0142836210079444e+00 3.4253500628703644e+00 1.9822510084209746e+00 1 0 -2 +274 1 4.5713678557713822e-01 5.4244335571632307e-01 3.0849174937154351e+00 1 -2 1 +314 1 1.8447059547300777e+00 1.1692544876557610e-01 3.3199499683474132e+00 2 0 -1 +408 1 3.1814603728989130e+00 7.4387930556111925e-02 3.3119410401147560e+00 -1 1 1 +142 1 5.0629800765951494e+00 4.5529434814892644e-01 2.8994044435235393e+00 2 -1 -3 +25 1 6.1307890615815195e+00 4.8707110399724851e-01 2.9156227033318936e+00 0 2 -4 +458 1 7.5149810474983081e+00 4.9072663758191898e-01 2.7754564040841219e+00 2 -4 0 +165 1 1.3117326379233891e+00 1.1343392736952256e+00 3.1076574691841947e+00 -2 2 2 +421 1 2.7633861789985827e+00 9.5478806243591052e-01 3.1957876340691875e+00 -1 -3 1 +151 1 4.7220243778881930e+00 1.4282004346636548e+00 3.2642378377455432e+00 0 0 -1 +162 1 5.6468847674841811e+00 1.3364063405496600e+00 2.5903751818453160e+00 4 -4 -2 +120 1 8.2129099591176686e+00 1.3575499019485984e+00 2.6634845511723606e+00 0 0 0 +448 1 8.8805142887530297e-01 2.2694079305496020e+00 3.1897834611367313e+00 -1 1 3 +50 1 2.9687835700409062e+00 1.9135157390691884e+00 2.8548074734572992e+00 -3 0 1 +443 1 4.0462687470728396e+00 2.3330394967344139e+00 3.1667340148022216e+00 0 1 -2 +482 1 4.9427462157614270e+00 2.1611442624383619e+00 2.6370759110090005e+00 0 3 3 +407 1 5.7753726348779013e+00 2.4435329312939671e+00 3.1756094964019836e+00 0 1 -1 +100 1 6.6610073695947598e+00 1.9476592422501362e+00 2.6046914024931409e+00 -2 -2 1 +99 1 3.5098260053604374e-01 3.2489377905726768e+00 3.1253385231740438e+00 -1 1 -1 +107 1 1.3942178307183000e+00 3.1914627339242005e+00 2.9813408440396350e+00 2 0 1 +480 1 2.3066257454835091e+00 2.6794898513136354e+00 2.7495660819550110e+00 -1 -2 -1 +115 1 3.1214377398204638e+00 2.9223083977660864e+00 3.3233156913824242e+00 1 2 1 +278 1 5.0520729931158854e+00 3.1424127338010743e+00 3.1175324674801042e+00 0 0 -1 +206 1 7.7081484276756580e+00 3.0580419350207482e+00 3.0362913717240096e+00 0 -1 -4 +4 1 1.3000434256419220e+00 4.1733384323360649e+00 2.6659576195319934e+00 1 0 2 +214 1 3.2669228431804429e+00 3.8002115979716740e+00 2.6408106015701289e+00 0 0 0 +65 1 4.0280349657536760e+00 3.3861374196314542e+00 3.2331032594455227e+00 2 1 2 +490 1 5.8571557116011554e+00 3.8735942685941813e+00 2.8613897619661586e+00 -1 -2 0 +230 1 2.4828380364158602e+00 5.5335473677805791e-01 4.1950137944148906e+00 2 -1 3 +234 1 4.2752320357614213e+00 1.4212800762204394e-01 3.7635975156407624e+00 -2 1 -4 +92 1 5.6957646578006917e+00 2.5374658514218495e-02 3.8304068113906884e+00 0 -1 0 +103 1 7.0230616578295741e+00 4.6755655210711161e-01 3.8662999072020967e+00 1 -2 1 +129 1 8.1671299320274162e+00 5.7067862198193264e-01 4.0702212708530077e+00 -1 -2 0 +483 1 3.2862260723228903e-01 1.4557716141563948e+00 3.6577409481728278e+00 -3 4 -1 +110 1 1.5047240722693447e+00 1.0396158231062973e+00 4.0843832165787424e+00 -2 -1 0 +126 1 3.7388270640303456e+00 1.1962750537841655e+00 3.4335639532998909e+00 3 0 0 +276 1 5.6087889039130960e+00 1.1358153696317190e+00 3.7428282467743927e+00 0 2 1 +294 1 6.5127919732673050e+00 1.4345197299837358e+00 3.4448769173070444e+00 -2 0 2 +417 1 7.5734653423068021e+00 1.3756634588591667e+00 3.5078056411981438e+00 -1 1 0 +102 1 1.1107713360470239e+00 2.0167473232388695e+00 4.1576658165713738e+00 -2 0 0 +228 1 2.0072330566273600e+00 1.8105875233272237e+00 3.4619908126078429e+00 2 0 -1 +2 1 3.2101113937010530e+00 2.0183489554560774e+00 3.8822820800419566e+00 0 1 -1 +222 1 4.2730523271288350e+00 1.9092752363315002e+00 4.1553216684001049e+00 1 -1 0 +332 1 6.5042309397343736e+00 2.2214607151080448e+00 4.1057034120156182e+00 0 1 3 +275 1 7.5099659540449100e+00 2.2790896507455778e+00 4.1566328430638730e+00 -1 0 -1 +243 1 8.2736142057938107e+00 2.3393256795577462e+00 3.4990413844829384e+00 0 0 -2 +394 1 5.8512440497757878e-01 2.8807282965119669e+00 3.9612614891397042e+00 1 3 1 +325 1 2.1875714466797338e+00 2.8726101452768167e+00 3.8147636089102748e+00 0 2 -1 +468 1 5.6059790271973755e+00 2.9975764588671621e+00 3.9816014902843078e+00 0 1 0 +113 1 6.5849924400139104e+00 3.1808065990344776e+00 3.4367361163256929e+00 0 0 1 +47 1 1.0081753047752569e+00 3.9556172416934308e+00 3.8502376136806813e+00 1 -1 0 +474 1 1.9694475511677239e+00 3.9381337754040748e+00 3.4201230948176762e+00 4 1 -1 +343 1 3.0370114219017328e+00 3.9465351732349148e+00 3.7436387890882474e+00 0 -2 3 +257 1 6.0639634839200358e+00 3.9545122043987475e+00 3.7922755780058259e+00 1 3 -3 +422 1 7.3939236737263112e+00 3.9358351587357783e+00 3.4932390476416106e+00 -2 -1 -3 +317 1 3.5159353631335000e+00 5.3479576975233323e-01 4.4869163379906354e+00 -1 -2 -4 +322 1 5.5733359556605757e+00 4.8698103039818835e-01 4.7704783768556309e+00 1 6 -1 +453 1 7.3567123647601029e+00 8.3432787155128474e-02 4.8780449077720851e+00 -2 3 2 +82 1 5.8224871123849942e-01 1.1896491837492689e+00 4.7267276175254507e+00 3 0 -1 +402 1 2.4848673528490579e+00 1.6438582837634208e+00 4.4663750233867230e+00 0 2 3 +201 1 3.5370299676438193e+00 1.4874347892452509e+00 4.7752714735806165e+00 0 -2 -1 +159 1 4.7745775925936407e+00 9.0511891230699659e-01 4.2787903105333260e+00 0 -2 2 +239 1 6.3670232447984816e+00 1.2120460051587267e+00 4.4601763672019308e+00 0 1 -1 +340 1 7.6240687426290750e+00 1.3432987598476136e+00 4.6741720105351368e+00 -2 1 1 +246 1 6.4819140516389595e-02 2.1918155429312383e+00 4.6033031341679633e+00 0 2 1 +268 1 5.2454607296226170e+00 2.0016193334579642e+00 4.2366338410742728e+00 -2 2 0 +238 1 1.7670560071066166e+00 3.0774892421151585e+00 4.7759677543328642e+00 0 0 0 +183 1 2.7500175098986750e+00 2.8066272725663279e+00 4.6976729622871014e+00 -2 0 0 +393 1 3.6570205199594930e+00 3.1994600133365143e+00 4.2220986255821451e+00 1 2 -1 +177 1 4.6077861627416805e+00 2.8922144055644265e+00 4.5492372075807843e+00 0 -1 0 +97 1 2.5306051464072796e+00 3.9363146816844674e+00 4.9489842130852137e+00 2 0 1 +16 1 5.1924745493168265e+00 3.7357318418579575e+00 4.8717896643693246e+00 0 -2 -1 +15 1 6.1086100243278070e+00 4.1952083415168335e+00 4.9407045230806066e+00 -1 0 -4 +467 1 6.6872865628091098e+00 3.3657369472951393e+00 4.6943068780100674e+00 1 2 2 +404 1 8.0052336596808171e+00 3.5358005023997046e+00 4.5274309747477952e+00 2 2 -1 +190 1 9.4380374464947103e-01 4.4583992222855645e-01 5.4653306453144710e+00 1 0 1 +429 1 1.8525920421435695e+00 3.5762708549602490e-01 5.0946475568663319e+00 3 0 2 +356 1 3.9097878727975877e+00 6.1716052733039095e-01 5.4734744838905147e+00 -3 1 -1 +459 1 5.0297951477539122e+00 6.4682655744305417e-01 5.6718176557063691e+00 0 1 1 +140 1 6.3845220800541655e+00 6.6200714540119532e-01 5.4418985717149972e+00 2 -1 -2 +121 1 6.3608122327251349e-01 1.6422337064097718e+00 5.7379184381145940e+00 -2 -1 -1 +76 1 2.6863089369401427e+00 9.2826845731889596e-01 5.1620994403726908e+00 -1 -1 -1 +24 1 4.4731219011860990e+00 1.5605471103773427e+00 5.2523372789875760e+00 0 -1 -1 +215 1 5.5638567276602870e+00 1.5540980050800413e+00 5.2788517723209116e+00 2 1 0 +406 1 7.1965017439495353e+00 1.2927814031197866e+00 5.6667263284723859e+00 0 2 -2 +495 1 8.1400977173034548e+00 9.1998286287268760e-01 5.5427200454151757e+00 6 1 0 +256 1 1.5858394354874155e+00 1.8927406862702940e+00 5.2157829401895270e+00 4 0 1 +348 1 2.8144079358075680e+00 2.0457885486401644e+00 5.4765038200952452e+00 1 -1 2 +18 1 3.7959072614405218e+00 2.4151932066273840e+00 5.1090004037855792e+00 0 -2 -3 +259 1 4.8058181463022738e+00 2.5068639859502841e+00 5.5173228168937900e+00 0 0 1 +261 1 5.9067727879570278e+00 2.4818772803689844e+00 5.0470051254431221e+00 0 0 -3 +433 1 6.6238775496086628e+00 2.4655070126810084e+00 5.8390299036823690e+00 -4 1 0 +119 1 7.4961811313748150e+00 2.2560858298720374e+00 5.2761246161627531e+00 0 -2 0 +181 1 8.7803165796510541e-01 2.5368621724963174e+00 5.1009676967579534e+00 3 -4 -2 +392 1 1.3563447389359846e+00 3.2004762283973394e+00 5.8237816659365569e+00 0 1 -1 +436 1 2.3946011665804514e+00 3.0278168308484168e+00 5.6997814720410966e+00 1 1 2 +210 1 5.9632298308600022e+00 3.3253508577291475e+00 5.7908436280268685e+00 0 -1 -2 +409 1 8.2954742717592467e+00 2.8784369153928258e+00 5.3508660402584347e+00 0 0 0 +437 1 7.8285811502936531e-01 3.5972247646914322e+00 5.1173576054548029e+00 -1 2 1 +114 1 3.5350435499222215e+00 3.3621891050940294e+00 5.4926280066777995e+00 0 -1 1 +431 1 7.2810459589983303e+00 4.1806346853520422e+00 5.1699487852752508e+00 0 -1 2 +296 1 2.7493301442805773e-01 9.8739001637521445e-02 6.5256735912844297e+00 2 0 -1 +477 1 2.7650505314326872e+00 5.9323041848923519e-01 6.1880566096904213e+00 -1 0 -2 +199 1 3.8449072993955937e+00 6.8021783868606100e-01 6.5252139926754094e+00 1 0 -1 +31 1 6.8196091485194961e+00 6.5962784856610523e-01 6.6694400071986637e+00 0 -2 -1 +149 1 7.6325509159351759e+00 1.3582393886225264e-01 5.8995743775761014e+00 0 1 -2 +216 1 9.7752025904362638e-01 1.4078822836813889e+00 6.6728311339234487e+00 2 0 1 +425 1 1.7005586383875275e+00 1.1280428057946255e+00 5.8993957526091192e+00 -2 5 2 +224 1 2.8675797989920913e+00 1.6348520503423174e+00 6.4743030869420952e+00 1 0 0 +352 1 3.7461129077349202e+00 1.6467836683144792e+00 5.9711819974315681e+00 0 2 1 +289 1 5.0071286046398447e+00 1.3773263732616476e+00 6.4710057868740503e+00 2 -1 2 +455 1 6.2266605172975309e+00 1.4566180649712972e+00 6.2025029141131824e+00 0 1 2 +298 1 7.2166245583854813e+00 1.5995071342823830e+00 6.6916596114412981e+00 -2 2 -2 +42 1 8.3616236989495309e+00 1.1193553859054726e+00 6.6834990220304640e+00 1 -1 -1 +80 1 1.7994758316879240e+00 2.0602535563487749e+00 6.2756102858385763e+00 1 -1 -2 +127 1 4.3098326176630284e+00 2.3959981453352577e+00 6.4129162374884245e+00 -3 2 -4 +232 1 5.4258898148163945e+00 2.3715461809208245e+00 6.2879862147301759e+00 1 1 -4 +368 1 8.2199446060636472e+00 2.1052670796140989e+00 6.3974575157449376e+00 -1 -1 -2 +486 1 6.9787179588597281e-01 2.5321347977480562e+00 6.5634477651369929e+00 1 -2 1 +209 1 1.7697882729109665e-01 3.3153947644324067e+00 6.2408024968147000e+00 -1 0 -2 +152 1 3.1591516689848946e+00 2.6297173021869003e+00 6.2970081587154914e+00 -1 3 2 +353 1 3.7775468094107074e+00 3.3545010039524996e+00 6.5652719772105916e+00 0 -2 1 +361 1 7.1568303860427589e+00 3.3402954049017803e+00 6.0487812936573579e+00 1 1 0 +391 1 1.8477885811255761e+00 3.9829271272845177e+00 6.5960694610186286e+00 2 0 -1 +464 1 2.8125899145281190e+00 3.9218837233739201e+00 6.1411786897515759e+00 -2 2 1 +497 1 4.5524588331963729e+00 3.4967999912980696e+00 5.9321819433594642e+00 1 -2 2 +498 1 2.0830532473234906e+00 1.1220036849985102e-01 7.1674325217309276e+00 3 3 -1 +264 1 3.1008573853993013e+00 7.6076625369238260e-01 7.2316131354301971e+00 1 1 2 +265 1 4.6342157774659736e+00 7.4471207241976944e-01 7.1556952519725225e+00 0 -1 1 +350 1 5.7838647346068255e+00 5.9645078928256690e-01 6.9763870948006925e+00 2 -2 0 +144 1 1.9122165150526358e+00 1.1329756208528616e+00 6.9185463020768152e+00 0 1 1 +17 1 3.7256587791934250e+00 1.6333740129131904e+00 7.1341698423474043e+00 0 0 0 +441 1 3.6115685474483350e-01 1.9101453221098965e+00 7.5303824824165133e+00 0 1 2 +266 1 1.4762191689510862e+00 2.4662450761248356e+00 7.5398542897976331e+00 -3 -2 -2 +375 1 2.3309589830172550e+00 2.0436669163885055e+00 7.1892097709618481e+00 0 1 0 +351 1 4.7143585284219309e+00 1.8434829864646978e+00 7.2780594229535307e+00 1 0 1 +254 1 5.9170265466448875e+00 1.9140788620193201e+00 7.1554204752492074e+00 0 1 0 +29 1 1.5191420610560982e-01 2.9876711650320327e+00 7.5404622831951533e+00 1 -2 0 +198 1 1.9302038195524280e+00 2.9894398797282253e+00 6.7310853131736357e+00 2 -1 -2 +197 1 3.3083005500744571e+00 2.6144599213348498e+00 7.4059907643060248e+00 1 0 2 +192 1 4.3810729888763209e+00 2.8557380429470860e+00 7.4007735378272006e+00 1 0 1 +220 1 5.1223945377780948e+00 3.3376038243952149e+00 6.7920010375935584e+00 0 0 1 +432 1 6.2458841824934863e+00 2.9482647398415351e+00 6.8353911959966540e+00 0 2 -1 +20 1 7.5153792083913968e+00 2.5459516140888447e+00 6.9548679851000408e+00 3 -1 -2 +63 1 1.0659006163620912e+00 3.4796280956085210e+00 7.1592343773906313e+00 0 1 -2 +446 1 7.1139268453604680e+00 4.0629892995134789e+00 7.0800362551664415e+00 1 -3 -2 +172 1 8.3244437231535144e+00 4.0795393733923691e+00 7.1857426258997332e+00 2 0 -1 +405 1 2.0158180111850474e-01 7.3000938410316307e-01 7.6191994505829879e+00 0 -3 0 +323 1 1.4017230037752237e+00 4.6050949606146502e-01 7.9006469000953414e+00 2 1 -1 +428 1 2.4287753885012338e+00 4.6438480937363963e-01 8.3560508824421493e+00 3 0 2 +280 1 3.6502596381287908e+00 7.8205464112991063e-01 8.2256571665042131e+00 3 1 -1 +54 1 5.2270258856938900e+00 5.3851997974995880e-01 8.1047016704593808e+00 -1 0 -5 +397 1 7.4044521194737944e+00 1.4880482327788007e-02 8.2278445496777337e+00 1 0 2 +279 1 1.2356833818326960e+00 1.5625251472088779e+00 7.9109615213928013e+00 0 4 -2 +134 1 2.5628613498785486e+00 1.5781156241932268e+00 7.9994516338459301e+00 0 1 -1 +236 1 4.5573192582583912e+00 1.4401963680745278e+00 8.1580516205465621e+00 0 3 -3 +493 1 6.1321864263285528e+00 9.9745261592364498e-01 7.9044637123188437e+00 0 3 -3 +346 1 7.4631508711766701e+00 8.7980227698742530e-01 7.6161632460447608e+00 2 -1 -1 +295 1 3.6674081936683844e+00 2.3602153939048316e+00 8.3119852957626765e+00 0 1 -2 +164 1 5.5460188609614756e+00 1.8259166833804881e+00 8.1712445391317772e+00 -2 -2 -1 +354 1 6.6872220974400829e+00 2.0300640265600358e+00 7.8561422683464270e+00 1 2 0 +449 1 7.9034553200360103e+00 1.8534144914629234e+00 8.0299472682703943e+00 -1 -3 0 +185 1 9.5448193278219684e-01 3.3578879558028460e+00 8.1917731250955708e+00 1 1 -1 +229 1 2.5099351180061946e+00 3.0097254013180406e+00 7.8296711975898541e+00 -2 2 -1 +135 1 5.5895093348111047e+00 2.7786209311728598e+00 7.5930433616327404e+00 -1 0 -2 +211 1 7.0529928021063730e+00 3.1919477500830000e+00 7.6370125321552074e+00 -2 2 1 +81 1 1.8872269150105381e+00 3.9351057043865243e+00 7.6163648141042426e+00 0 -1 1 +37 1 3.6614705509244851e+00 3.4915765263742262e+00 7.7267865376074960e+00 2 0 1 +355 1 4.5831332879360058e+00 3.8667909487066860e+00 8.3349240075214972e+00 1 -2 0 +141 1 5.4975686789962985e+00 3.7534665361901731e+00 7.8536976598839008e+00 1 3 1 +122 1 7.2999342247943373e+00 3.9738648524411286e+00 8.3865006440763370e+00 0 -1 -2 +327 1 3.2503689184711210e-01 4.6592524224991747e+00 8.2659471361477532e-01 0 -2 2 +386 1 1.1858359917362140e+00 4.2742921253409367e+00 2.8183822072239956e-01 -1 -2 5 +59 1 1.8702404230468521e+00 4.9717730076471947e+00 7.6874981917086671e-01 0 2 -3 +57 1 2.8167286953460633e+00 4.2569068178507328e+00 1.1953882254793591e-01 1 -1 1 +489 1 3.6302378764516323e+00 4.4521177967574310e+00 6.6729235313037527e-01 1 1 5 +326 1 4.9856357064009993e+00 4.5330987087989216e+00 5.2454407858907726e-01 -1 2 2 +359 1 5.9913033298564331e+00 4.3362327743167306e+00 3.7835915829420080e-01 2 -1 -1 +349 1 7.2426723526689933e+00 4.7181533524380885e+00 7.2707643667494415e-01 0 1 -2 +247 1 8.6433343008963215e-01 5.6823007167579762e+00 6.5224250416194052e-01 1 -3 2 +365 1 3.8233209759419231e+00 5.6939269324333672e+00 5.9607489711922135e-01 -1 -1 0 +382 1 5.1137068164970731e+00 5.5805604939667059e+00 1.8276059551769425e-01 -1 -2 1 +130 1 8.2482820181805554e+00 5.5968590423898927e+00 4.4653409437071251e-01 -1 -1 2 +471 1 1.7119665678072469e+00 5.8953695416344436e+00 4.5930053740843135e-02 -2 0 1 +21 1 2.5641267140454049e+00 6.3080369711057624e+00 5.3936073769936865e-01 1 -2 0 +499 1 4.7164689695839286e+00 6.6465500795405017e+00 1.6611623106065540e-01 -1 -1 1 +253 1 5.9043290983731245e+00 6.1331552003521068e+00 7.5404520106110218e-01 3 -1 0 +302 1 6.9564884663410282e+00 6.1640675729464434e+00 5.7033134187391044e-01 0 -1 -1 +324 1 8.1992983060509594e+00 6.5972265856779417e+00 7.7494747996129210e-01 1 -3 2 +154 1 1.8996589089571863e+00 7.1193783454022102e+00 5.1404963792269565e-01 -3 -1 -1 +284 1 3.0007790559640597e+00 7.2198187648711993e+00 2.3642486802169203e-02 0 0 0 +161 1 3.8133207311484072e+00 7.3201299304675667e+00 5.0202507839899535e-01 -2 -4 -2 +112 1 5.6724794675417822e+00 7.1979165692397187e+00 7.3233205047939343e-01 -1 -3 -2 +39 1 6.4178033104766934e+00 6.8891409921259603e+00 1.5315709015991064e-01 0 0 2 +269 1 7.4906317471214443e+00 6.7375050108085421e+00 4.8287801879068511e-02 3 1 0 +470 1 2.2822847309207428e-01 7.8917014242385868e+00 7.7675485207454809e-01 0 0 1 +84 1 1.3672512040847244e+00 7.9379711016796204e+00 1.6230344562139010e-02 1 0 -3 +381 1 2.6740213254054948e+00 8.0161072175846630e+00 5.8246256296805565e-01 -1 -1 1 +416 1 3.6213693754100857e+00 8.3576521057616233e+00 6.2331560400527297e-01 2 2 -1 +182 1 5.1660049409085866e+00 8.0423641799361949e+00 3.0675573970032322e-01 -2 0 -1 +347 1 6.5429973279348026e+00 7.8912499362162034e+00 4.9818784876300565e-01 -1 1 -2 +380 1 7.4990421428201417e+00 7.6756533739549013e+00 7.5184655726615468e-01 -3 0 0 +19 1 1.4643514526638863e+00 4.2228380130315317e+00 1.3843336624933156e+00 0 3 -1 +430 1 4.3057981012626918e+00 5.0291601875436083e+00 1.2152759600723888e+00 1 1 -2 +212 1 5.0477378389079224e+00 4.2727344176247888e+00 1.5457805058503180e+00 -2 -1 2 +479 1 7.9063585867776194e+00 4.9679041912501303e+00 1.6188677256489217e+00 1 3 -1 +217 1 2.5218672599222897e-01 5.8414577361250837e+00 1.5087288813722908e+00 2 1 2 +147 1 1.1545026869668784e+00 5.3345315151941692e+00 1.5114087897016817e+00 1 2 -1 +13 1 2.8751716646412713e+00 5.2058560720828826e+00 1.0454367061984737e+00 -2 1 -1 +170 1 5.1473087472466297e+00 5.7979187654554183e+00 1.4646868436401976e+00 1 2 0 +204 1 6.2817592200581442e+00 5.1972845711964553e+00 8.9956483663207842e-01 -1 -1 -1 +306 1 8.3865328816009488e-01 6.6369969836196416e+00 9.5403861420405511e-01 1 -1 3 +414 1 1.6815920771923107e+00 6.1626367729687450e+00 1.1744973520180511e+00 0 2 0 +79 1 3.3223472300560521e+00 6.2059256452802716e+00 1.3962300133956274e+00 0 0 0 +116 1 7.6213827835593815e+00 5.9109006810695996e+00 1.2032264335528675e+00 -2 -1 3 +231 1 2.7502476364406934e+00 7.3933926752228123e+00 1.4247539952768773e+00 3 -1 1 +171 1 4.7071880050572981e+00 6.8064285791523735e+00 1.2807974821888473e+00 0 -2 1 +273 1 7.0329000376929018e+00 6.8584131720717227e+00 1.6693583798609657e+00 -2 1 -1 +260 1 8.0496857982994889e+00 7.4547112671714686e+00 1.6374112984134654e+00 3 -1 -2 +43 1 1.0723712760276345e+00 8.0330657119523838e+00 1.4245919245059160e+00 -2 1 0 +208 1 4.3910624755767662e+00 7.9590156044378260e+00 1.1638330407357564e+00 -2 -2 -1 +226 1 5.5077902922207063e+00 8.0548948337249193e+00 1.2764179622713128e+00 0 0 2 +370 1 6.4142184578798505e+00 7.6748965104033502e+00 1.5118878610721513e+00 1 1 1 +85 1 4.9493682223295465e-01 4.4925581352788218e+00 1.7962077237252332e+00 2 0 0 +213 1 2.1575495906041722e+00 4.9142597626853277e+00 1.8811900528366003e+00 0 3 0 +299 1 3.3659976969419567e+00 4.3662606017243588e+00 1.7255850309353928e+00 3 -1 -2 +249 1 4.7082373488231886e+00 4.9470082900514569e+00 2.3877787475724284e+00 0 0 1 +258 1 5.7775488222451887e+00 4.8696821219175135e+00 2.2927307255193869e+00 -1 0 -1 +388 1 6.8398302583746604e+00 4.7642336931962808e+00 1.8670074890749995e+00 1 -4 -3 +91 1 7.7108281252011066e+00 4.3462922152329373e+00 2.4115614404022634e+00 2 -2 1 +415 1 1.3354264256961873e-01 5.2683808667768846e+00 2.4940378524658144e+00 0 3 0 +27 1 2.0564207334277329e+00 5.6999752852325889e+00 2.4901436865643838e+00 0 -2 -1 +465 1 3.6077777180133985e+00 5.3106225786683270e+00 2.2984375934854913e+00 1 4 2 +72 1 1.2115862831734683e+00 6.3271145377400213e+00 2.3088380865765914e+00 -1 -2 -1 +58 1 2.4730215910430200e+00 6.4108021967014599e+00 1.8872921058165837e+00 2 -2 2 +88 1 4.2468496124355051e+00 6.0000736368680991e+00 1.9689248186008255e+00 1 0 -1 +6 1 5.2824888171486872e+00 6.1177755165021708e+00 2.4648490036232666e+00 0 -3 1 +75 1 6.5540148621238368e+00 5.8837981825070473e+00 1.8049347572360399e+00 -3 0 4 +22 1 7.8390642986715990e+00 6.6390504342942007e+00 2.2941937725662940e+00 0 1 0 +128 1 5.0900588055916374e-01 6.9175984002222233e+00 1.8531623061329514e+00 -1 0 1 +193 1 1.7616411201473283e+00 7.3777929885216569e+00 1.8819221158557660e+00 -2 0 0 +389 1 3.8054852300865960e+00 7.1908689074118346e+00 1.6897648139570383e+00 1 -1 -1 +241 1 3.3304867419800805e+00 6.7201719117843943e+00 2.3881392654044515e+00 0 1 0 +14 1 5.6091745306383807e+00 6.8869789388403264e+00 1.7385824045568810e+00 0 -1 0 +307 1 2.6028552221612093e+00 7.5983757451277896e+00 2.5134014261731092e+00 -1 1 0 +401 1 3.3924470446908370e+00 8.2185878004411617e+00 1.7224400376656741e+00 -3 -2 2 +248 1 4.8372436612670020e+00 7.6440956091999794e+00 2.0947200376368853e+00 2 -3 0 +335 1 7.0823280457514208e+00 7.5905134700352388e+00 2.4694687185743178e+00 -1 0 0 +281 1 7.4000691269637358e+00 8.3890728034516613e+00 1.8965880690997261e+00 -1 -1 0 +33 1 2.6215904333511340e+00 4.6944190932346643e+00 2.8031190571610427e+00 1 1 1 +221 1 3.7745777664099962e+00 4.5666560881588492e+00 3.0592511133135365e+00 0 -1 1 +251 1 6.7715334943605834e+00 4.6401458096684580e+00 2.8510683358464712e+00 1 -2 -2 +138 1 1.1922779528936784e+00 5.1973855619084013e+00 2.5689556972218521e+00 0 1 0 +73 1 4.3331751132449305e+00 5.7904710852531096e+00 2.9618985356431899e+00 0 -2 2 +237 1 6.2300560736724488e+00 5.7475979505901522e+00 2.7248929404434143e+00 3 0 0 +77 1 7.3913602469000059e+00 5.6780386160747609e+00 2.6234944353061729e+00 -1 -1 3 +339 1 2.9546703425028309e-01 6.2132195219954411e+00 2.7867557714215443e+00 0 0 2 +69 1 1.3562182919504069e+00 6.0134582221288868e+00 3.2785943115156346e+00 0 -2 1 +150 1 2.9668876558472732e+00 5.9472670316673391e+00 2.8936146954206632e+00 3 -2 -1 +219 1 1.1608118939764323e+00 7.3228681938207032e+00 2.7126116817865631e+00 0 -3 -1 +9 1 2.0627854045350777e+00 6.7454186793237145e+00 2.9360002216641958e+00 0 -2 -2 +3 1 2.9445094497077151e+00 7.1384526732484925e+00 3.3587771406211751e+00 2 -1 -2 +93 1 3.8294061315771235e+00 7.5378392781893275e+00 2.8380550678413003e+00 -1 2 0 +68 1 4.5306997862577427e+00 6.7390306077267583e+00 2.7235217150491495e+00 1 1 3 +35 1 5.4701910601523354e+00 6.9880160912814793e+00 3.3190052755169512e+00 0 0 -2 +174 1 6.2873908725084267e+00 6.7805871501360224e+00 2.7219816088319484e+00 -1 0 2 +369 1 1.7965435829527715e-01 8.0388194202620209e+00 2.5940286664394834e+00 -3 -2 1 +469 1 4.9516921171039039e+00 7.8826764349301754e+00 3.0530014528334970e+00 0 -2 -1 +270 1 5.8608285132223106e+00 7.6946678024150144e+00 2.6778659829007898e+00 0 -1 -2 +196 1 7.6768577919393455e-01 4.8792664640921366e+00 3.5903070116215088e+00 3 -1 1 +235 1 4.2285310787746502e+00 4.2638690385284841e+00 4.1560966227762339e+00 1 1 1 +104 1 4.9767847616154004e+00 4.2048445393860883e+00 3.3962447019771562e+00 -1 -2 4 +363 1 5.8883238331527643e+00 4.9482373301020921e+00 3.4294316309792547e+00 0 0 3 +440 1 8.3695482926311691e+00 4.2129368246316421e+00 3.4018022112738615e+00 -1 2 1 +271 1 1.8521235523587734e+00 5.0753345126075313e+00 3.3807703470063983e+00 0 2 1 +385 1 3.2904276665596646e+00 5.1796485809465160e+00 3.7980367644038786e+00 -3 -1 0 +367 1 4.4116421156217953e+00 5.2602223360914149e+00 3.9453911592241386e+00 1 1 0 +8 1 5.3112651984610038e+00 5.7540585999932050e+00 3.4831459566385630e+00 3 1 0 +445 1 6.8973470747727381e+00 5.7304789961834581e+00 3.7043310817118127e+00 -2 -1 2 +95 1 8.3390772303693836e+00 5.5440620917552232e+00 3.7707087770664116e+00 -2 1 -3 +227 1 2.6907357337748437e+00 5.9773212885609901e+00 3.9377639031978284e+00 -1 -2 0 +45 1 3.9484717591019058e+00 6.4426795460159951e+00 3.6915638730283460e+00 0 1 -1 +62 1 6.2921228111843934e+00 6.5338531152740655e+00 3.8634903896998787e+00 1 0 -3 +309 1 7.4708902093515182e+00 6.5908652825436720e+00 3.6007172393059794e+00 0 -2 0 +70 1 1.1631280783050528e-01 7.0230287218135894e+00 3.4578008409773004e+00 -1 -2 2 +285 1 1.4425208756199777e+00 7.4192404188139784e+00 3.7903676842933867e+00 0 1 -1 +387 1 2.1212416378368082e+00 6.7926691438538640e+00 4.1965603113934069e+00 1 -2 -1 +484 1 4.6356188966878253e+00 7.3783035166039177e+00 4.0565969174155132e+00 0 -1 -1 +98 1 6.8865210518165370e+00 7.3140090488700187e+00 4.1918733358514384e+00 0 -2 -2 +282 1 6.6401301602074470e-01 7.9757076330778913e+00 3.4568068256572881e+00 0 0 2 +203 1 2.5721741898113022e+00 7.9369081377447577e+00 4.0156309667060688e+00 0 3 0 +189 1 3.6912207664687133e+00 7.6806375475121094e+00 3.9059717431750585e+00 0 -1 0 +267 1 6.5713653654298607e+00 7.8128923355065503e+00 3.4078724648171090e+00 -3 -3 2 +155 1 7.9603563078893247e+00 8.1399268391964696e+00 3.4070072411074963e+00 -2 -3 -1 +313 1 1.7289301235151016e+00 4.3022360027322257e+00 4.5514630316827649e+00 0 1 -2 +250 1 3.3811553057719541e+00 4.4820133651244189e+00 4.8062617116575304e+00 1 1 1 +49 1 5.2294045670482578e+00 4.6507731504297771e+00 4.3588420415784839e+00 -1 2 -1 +111 1 6.9650608689197728e+00 4.6666276346705935e+00 4.3879356756979719e+00 1 1 -1 +124 1 8.0933085752880096e+00 4.6382186065764790e+00 4.3125441053619298e+00 1 1 -1 +488 1 5.0933114935797996e-01 5.1359886989747769e+00 4.5948583401263194e+00 -3 1 -2 +48 1 1.5851307073885004e+00 5.5767207395220701e+00 4.2311661806996650e+00 2 -2 1 +123 1 2.5153837170534041e+00 5.0458650845269890e+00 4.5131929409242613e+00 -1 -1 -1 +423 1 5.8208012531410862e+00 5.4948336589690365e+00 4.5916227902397422e+00 2 1 2 +329 1 7.4993364070942770e+00 5.4866100873090584e+00 4.5194723854672301e+00 -2 -2 -2 +334 1 7.1205767430238509e-01 6.1834005542640256e+00 4.2284519502384050e+00 0 1 -1 +146 1 1.3925739327604780e+00 6.6428737862846399e+00 4.8806888882719424e+00 0 1 -2 +500 1 2.2236367185474757e+00 6.0145074663436873e+00 4.9428276989368829e+00 0 1 1 +46 1 3.3290620592760245e+00 5.9295614805296450e+00 4.9789176350871935e+00 1 -1 -3 +374 1 4.7036984817853460e+00 6.2326093994181564e+00 4.3534332596232463e+00 -2 3 2 +52 1 6.8604388860085521e+00 6.3207993870641257e+00 4.9959828655023273e+00 0 -1 -1 +466 1 8.0663702260053096e+00 6.4797694103942982e+00 4.3885769098322607e+00 0 -1 -1 +272 1 6.3857634591010626e-01 7.4306626388140797e+00 4.4685908728843007e+00 -1 0 -1 +331 1 3.1923815943971330e+00 6.8406621847783482e+00 4.3673687027144910e+00 -1 -2 0 +12 1 5.5841339297795631e+00 7.2882403606371549e+00 4.4466343965097535e+00 4 3 0 +178 1 7.5912726284672463e+00 7.0457277620611389e+00 5.0302483408547527e+00 1 -2 0 +376 1 3.5187241629329796e-01 8.3977706803073371e+00 4.6278412560289910e+00 1 -5 2 +117 1 1.3379826357324891e+00 8.3239351364630743e+00 4.2945291322530599e+00 3 0 1 +419 1 1.8896223988418746e+00 7.6393579746671740e+00 4.8168734901107717e+00 0 1 2 +379 1 3.9801436864751545e+00 7.7556819889833708e+00 4.9922836416209275e+00 -1 -2 0 +53 1 4.7488025467298804e+00 8.2113497019933241e+00 4.7088252949914393e+00 -3 0 -1 +28 1 6.4645893658779787e+00 8.2802587137451660e+00 4.5908064174413035e+00 -1 0 -2 +300 1 8.0497419370896441e+00 7.6196002867575432e+00 4.2909429383935933e+00 0 3 0 +83 1 1.5533997706565803e+00 4.2394383012204173e+00 5.5726999917011435e+00 0 0 -1 +304 1 2.5788446900543724e+00 5.0166498820006939e+00 5.6119573167673691e+00 0 -1 0 +51 1 4.2443804124641717e+00 4.2352637746580450e+00 5.1927633388220640e+00 -2 -3 1 +180 1 8.3861058182094546e+00 4.2682396578102644e+00 5.2739914655295381e+00 2 -2 0 +60 1 1.6015559581031933e+00 5.1463292330916399e+00 5.1677022459932900e+00 3 -3 0 +255 1 3.9377408204864559e+00 5.5446289337866919e+00 5.6880007643189954e+00 -1 1 -1 +336 1 4.8593163697287496e+00 5.2245778091909907e+00 5.0488368666183758e+00 0 -1 0 +74 1 5.8562368106306470e+00 5.1343487602136690e+00 5.4844996621256241e+00 -1 -1 -1 +11 1 6.8757956599703460e+00 5.1962144116573894e+00 5.2833696751528123e+00 1 -1 1 +106 1 7.8813740148695439e+00 5.1326569274050362e+00 5.5073989898629776e+00 -2 0 1 +342 1 6.9861903942379322e-01 6.2397324279420259e+00 5.5554818983126264e+00 1 2 1 +366 1 1.5648860489287066e+00 5.8898927909510999e+00 5.8373116466465662e+00 -2 1 1 +153 1 2.7314006683241487e+00 6.0747252624615822e+00 5.8658792109688322e+00 2 0 0 +384 1 3.7649825100367740e+00 6.6140228235604797e+00 5.7068894568556274e+00 3 0 -1 +444 1 5.5919895424131791e+00 6.4007885907393334e+00 5.0609268438363237e+00 0 0 1 +169 1 8.1101285040334883e+00 6.0263607659074259e+00 5.3262646023669920e+00 2 -3 2 +312 1 1.5049751572049341e-01 7.0899457593186419e+00 5.3993285616214672e+00 -4 -1 2 +131 1 2.1405833530478784e+00 6.8932472731161107e+00 5.7016479425245992e+00 -1 -2 -5 +290 1 2.9965099079972810e+00 7.1703954961127128e+00 5.3705836189910157e+00 3 2 0 +240 1 4.7341951239220323e+00 7.1100411829110195e+00 5.1242936547927025e+00 -1 -4 5 +403 1 1.1346681749692125e+00 7.6627110490212882e+00 5.5800616996766177e+00 -3 2 3 +438 1 2.6845809734218404e+00 8.2016169024289791e+00 5.0687325841194584e+00 0 1 1 +420 1 4.5890023008209200e+00 8.1137042645946345e+00 5.6817522441295134e+00 -1 -3 -3 +175 1 5.5503185230040479e+00 7.9962207684468503e+00 5.3390442156703726e+00 -1 -2 1 +305 1 6.7862386693055941e+00 7.6108734242812508e+00 5.4748415197806564e+00 -1 0 0 +341 1 7.4912815420537060e-01 4.3291768420078673e+00 6.1635194432999105e+00 -3 0 0 +291 1 3.3895079643780628e+00 4.7034241504608403e+00 6.1615817441829774e+00 -1 0 1 +372 1 4.6184126650372983e+00 4.6292373343220516e+00 6.3125880555070495e+00 1 -1 -2 +293 1 5.5228203863122962e+00 4.2760181362826257e+00 5.8887719440294752e+00 2 2 2 +461 1 6.6292898049431850e+00 4.3535966489510214e+00 5.9130834363303126e+00 0 -1 -1 +263 1 7.7259268091094802e+00 4.4631499768470926e+00 6.3337285974251110e+00 -3 0 0 +473 1 5.8703225638324330e-01 5.3945075957215893e+00 6.1889975824903258e+00 1 -2 0 +166 1 1.6857123760309740e+00 5.0889285259544463e+00 6.6009674185523135e+00 2 2 2 +132 1 6.2122393744706681e+00 5.4126385838431412e+00 6.6911128610756689e+00 -1 2 1 +32 1 7.1447545314606753e+00 5.2817185569927805e+00 6.2574893275776935e+00 -1 1 0 +475 1 3.1727782520787395e-01 6.3991068893590928e+00 6.5410008153956287e+00 -1 2 0 +283 1 3.2886765713157047e+00 6.4577609617474216e+00 6.6450211825759427e+00 -2 5 -3 +205 1 4.9096514414971573e+00 6.2573093659948649e+00 5.9509143564095108e+00 1 1 0 +158 1 6.0709604726562620e+00 6.0618280221451721e+00 5.9241072976562341e+00 2 -3 1 +1 1 6.8533858129590133e+00 6.5562074315723597e+00 6.5648993855676077e+00 -2 -1 -2 +485 1 3.8125590702509465e-01 7.4616693598979804e+00 6.3609885403345947e+00 0 0 1 +378 1 1.3081995382782592e+00 6.9194359283210023e+00 6.2966360730695206e+00 -1 1 2 +71 1 4.2456384497919455e+00 6.8188407430282236e+00 6.6601493363974615e+00 -1 -4 -4 +320 1 5.9836892193800049e+00 7.1597807912498039e+00 5.9293654675383980e+00 -1 -1 -4 +481 1 7.6691355446374123e+00 7.2329848679784536e+00 6.1548343866270958e+00 2 0 -4 +318 1 1.3774303149915195e+00 8.3818831122591373e+00 6.3319633954681702e+00 -1 3 3 +496 1 2.5904412000483283e+00 7.6460489519926949e+00 6.2257027413180230e+00 0 1 0 +319 1 3.7413059213345305e+00 7.5724262762451815e+00 6.0123092822785358e+00 -2 0 0 +338 1 5.3628717868866635e+00 8.0629328638364353e+00 6.4489666989888104e+00 0 0 2 +358 1 6.2532288322758314e+00 8.3160028104100370e+00 6.1106737733333700e+00 1 1 3 +225 1 7.1188694406828850e+00 8.0966599202958953e+00 6.7037213079900431e+00 0 0 1 +55 1 1.0372861368831470e+00 4.4696141893250934e+00 7.4049774120079697e+00 -1 2 -1 +362 1 2.7501402171762614e+00 4.4083355662417896e+00 7.3996418874276850e+00 1 -1 0 +36 1 3.7396318187704796e+00 4.4801126663955504e+00 7.1074085083223073e+00 2 0 -2 +133 1 4.7860445539287522e+00 4.2902205437459102e+00 7.3711360387569274e+00 -1 -3 -2 +412 1 5.8687821857033606e+00 4.2035753083199188e+00 6.8227572622514323e+00 -4 3 0 +89 1 9.1212528791654535e-02 5.3554487915969240e+00 7.1088625783964092e+00 0 -2 0 +38 1 1.2571311964388701e+00 5.7525434192639207e+00 7.3210178579367868e+00 -1 -5 -2 +337 1 2.7511266822038212e+00 5.4161467707559394e+00 6.9980055112843935e+00 1 -2 -1 +233 1 3.8756258886529467e+00 5.7508116329978627e+00 7.0533607828281815e+00 0 0 -1 +442 1 4.9084237493694953e+00 5.5326539633780083e+00 6.7666717819135362e+00 -4 -4 1 +143 1 5.5776680237268401e+00 5.1621486864820874e+00 7.4635021710959082e+00 1 2 -2 +194 1 7.1453664245542576e+00 5.0984438205910134e+00 7.3333812213368574e+00 0 2 0 +308 1 7.5489760640996861e+00 5.8433222820659871e+00 6.9295207313931844e+00 0 0 0 +286 1 2.1326326019163346e+00 6.2556170719743678e+00 6.7379074391662934e+00 2 0 -2 +61 1 5.6654689088882648e+00 6.2935208603774795e+00 6.9534505775907345e+00 -2 1 -1 +426 1 7.2244687144599562e-01 7.0806885112202815e+00 7.2261712082790313e+00 -1 1 -2 +450 1 1.7213783340257280e+00 7.5184636193370302e+00 6.9767252413839369e+00 4 1 1 +188 1 2.8213470931093725e+00 7.2342621084044723e+00 7.1806231926796817e+00 0 -2 -1 +94 1 3.8026924767351562e+00 7.3932541518378949e+00 7.4596688811177305e+00 -1 2 -2 +252 1 5.1481924139065534e+00 7.2239227196376481e+00 7.0808756518162852e+00 -2 1 -1 +321 1 6.2155610611385042e+00 7.5199920009866501e+00 7.0964075868161212e+00 1 -1 -3 +156 1 7.9944514874782193e+00 7.0252703915440122e+00 7.2541499279788821e+00 -2 1 0 +167 1 5.6917482122629082e-01 8.1417190335213725e+00 7.4962901784513347e+00 2 -2 -1 +330 1 3.3138446283251373e+00 8.2146300363312132e+00 6.8886408760800295e+00 1 -2 0 +195 1 4.3712446295554876e+00 7.8995454090647614e+00 6.7366600234979277e+00 -3 -1 -1 +78 1 5.1856313345157918e+00 8.2127013524100576e+00 7.4620544007464273e+00 0 -1 1 +157 1 7.9011697675935482e+00 8.1764884669087454e+00 7.4266272279794077e+00 -1 0 -1 +373 1 6.7132530681439118e-01 5.0292807223694753e+00 8.1874843860841438e+00 1 2 -2 +56 1 1.7078519119356448e+00 4.9344764637762015e+00 8.1280520422148399e+00 0 2 0 +315 1 3.6234275175752244e+00 4.9451657793378052e+00 8.0476764469560074e+00 -1 -2 0 +478 1 6.4485922344872577e+00 4.3096951707056732e+00 7.7984645181472576e+00 -3 -1 1 +109 1 8.0579925616842267e+00 4.7034410927383776e+00 8.0870676538969590e+00 -1 -2 0 +357 1 2.6884169416542560e+00 5.4427652520296803e+00 8.2033924998655703e+00 0 3 1 +454 1 4.5709826050185614e+00 5.3780110248528246e+00 7.7764192595368709e+00 1 -1 2 +86 1 6.2280039286639228e+00 5.4780735688869227e+00 8.2809905303020894e+00 -1 1 0 +262 1 7.2349855745224341e+00 5.4460551342647063e+00 8.3066978094955939e+00 0 -2 2 +160 1 6.0572932237795518e-01 6.1031638741150802e+00 8.0606222325454144e+00 2 -1 1 +168 1 2.6926304594044645e+00 6.3106981827881823e+00 7.6217004925278191e+00 -1 -3 0 +145 1 3.6817206885980216e+00 6.4794531849637744e+00 8.1206460236595284e+00 -1 -1 -2 +400 1 4.6165015313151514e+00 6.4768264075412638e+00 7.5742703650137084e+00 1 -2 -2 +395 1 5.5951136272170219e+00 6.3298964082146654e+00 7.9312370644766386e+00 0 0 -1 +297 1 6.6597873155694378e+00 6.3692836044578955e+00 7.6364845321455510e+00 1 -4 0 +207 1 8.0115395128671594e+00 5.9375044868831406e+00 7.8466324008781454e+00 -1 1 3 +460 1 6.6754980612335257e-01 7.0521823363262239e+00 8.3451452216672077e+00 -2 1 -3 +44 1 1.5985553198249884e+00 6.8250382119954756e+00 7.7469635466673052e+00 0 1 0 +377 1 4.7397084186898368e+00 7.4631435688157008e+00 8.0338331164055763e+00 0 -1 0 +411 1 5.8132963527118724e+00 7.4646663474419555e+00 8.0261071780587709e+00 2 -1 1 +396 1 7.0242838781762282e+00 7.3479893628886632e+00 7.6603703429086574e+00 2 3 0 +424 1 8.1516255787718581e+00 7.5530513248894016e+00 8.2349155971796755e+00 -2 0 0 +66 1 2.2362583327280716e+00 7.7449451931440727e+00 7.8847519662235594e+00 -1 -2 0 +371 1 3.1656541571472099e+00 8.2451918974189500e+00 8.0415029551628514e+00 1 -1 1 +186 1 4.1675976318493086e+00 8.3247658596031009e+00 7.8802494669419030e+00 1 -1 -1 +413 1 6.4945159878598346e+00 8.3677431053238660e+00 7.6981134933049891e+00 -2 -1 -2 + +Velocities + +7 -1.5197672199477208e+00 -7.1031250708487148e-01 -4.0950627961412567e-01 +398 9.4644999179644840e-01 -8.0422358764146151e-01 -1.1023964746841350e+00 +173 4.8084218242595870e-03 -1.9383808513915850e+00 9.3439099328992314e-01 +462 -1.6390116924948674e+00 -1.2080683544699562e+00 7.6685759600965364e-01 +383 1.2945118204202577e+00 -1.8370931432093225e+00 1.1758972656982776e-01 +288 1.2113220352829337e+00 4.8786819623543370e-01 7.1439798712590263e-01 +303 3.6232856211831610e-01 -3.7927260062054236e-01 -3.0467891118546553e-01 +491 1.6817821327211264e+00 6.3153250223994289e-02 -5.4827183875981267e-01 +187 5.6164532616475686e-02 1.3250338697636479e+00 1.6291294556417517e+00 +163 1.3950518510134631e+00 -1.7090097072259662e+00 -6.0029200570353536e-01 +345 -8.4635427449528189e-01 1.3013642733988193e-01 -3.7582537476409439e-01 +447 -5.5306523194731427e-01 -1.4583063079290524e+00 4.8086237208854654e-01 +108 -3.1879632824306825e-01 -4.9387838912491844e-01 -3.1046215530949173e-01 +427 2.4456665882970424e-01 1.3737057789182878e+00 -1.7474218101951866e-01 +96 -2.8217287015277487e-01 3.9138367367476778e-01 -4.6114700958040086e-02 +494 3.0303709765292064e-01 -9.2861341821366045e-02 -3.6692009603190118e-01 +360 -4.2709052063514102e-01 -1.5167804301477015e+00 -2.6902074926466563e-01 +179 -1.2403873183879999e+00 1.1368400311662936e+00 5.6653449328883521e-01 +136 -1.5859168963178476e+00 1.0728794555657983e+00 5.0876417522892092e-01 +311 -1.4232560247874224e-01 -8.2802934475265932e-01 1.0289469027582252e+00 +242 -1.3753994053365912e+00 3.0823812109914095e-01 1.2519475129774249e-01 +451 1.0684545083916284e-01 -1.3647250068831975e+00 1.2292458701523420e-01 +118 6.5344809858683794e-01 -6.0529931820910909e-01 -6.6821572295625731e-01 +200 -9.1497459004230530e-01 -7.2783581485393822e-01 -8.5265666689286446e-01 +23 1.0121027757280427e+00 -5.8690115135784995e-02 -1.4283745590726701e-01 +30 -1.2406061152582815e+00 3.7490020292637088e-01 -1.4457935973251330e+00 +26 -9.9581994312158117e-01 -1.2441026541932486e-01 -3.6541440712112250e-01 +452 -9.8588039362152369e-01 1.0706468502992672e+00 1.6282162085617651e+00 +439 -1.2386761163593085e+00 4.3106305328993799e-01 5.0410115305724934e-01 +492 2.7094066326642935e-01 6.6318883302565457e-01 1.5999014287193769e-01 +287 -1.7254693201510321e-01 1.1189096817152451e-01 4.1489954379924110e-01 +87 -1.1416496451717975e+00 -7.8732701356097490e-01 -5.1553483379997289e-01 +191 1.2771897324335735e+00 -1.7496443253093807e+00 5.0507874089360993e-01 +316 9.1440987552186193e-01 5.4700363415289210e-01 9.8622452705158947e-01 +176 1.8575029150961730e+00 4.1139607157872565e-01 -7.4590595351664335e-01 +244 -4.6943526746297531e-01 -4.0598167955478592e-01 1.2148844546685273e+00 +463 -6.0334643189530614e-02 9.0710610807033173e-02 -1.1159129056326442e+00 +101 -4.6185710842519001e-01 -1.0745733134156132e+00 -8.4095960640252343e-01 +456 7.3559492687866046e-01 8.4585098605759870e-02 9.9419285892741016e-02 +90 -6.9201778873218364e-02 4.2798282427303436e-01 4.4566581747153294e-01 +457 -2.4132420839469965e-01 8.4836564798364844e-01 1.0955942184355154e+00 +344 6.5538410556645377e-01 1.0527852545027427e+00 6.8154568558028386e-02 +399 -8.3144103937947644e-01 1.9062875610231711e-01 -5.6419101062513155e-01 +472 7.2667243545881360e-02 4.9535613585667015e-01 8.3691870718219108e-01 +364 -2.9526170592863293e-01 -8.7862728527604539e-01 8.2689159018968139e-01 +333 1.7241045239522232e-01 1.0435495829586168e-01 -4.6109306717747689e-01 +223 3.7919285550573256e-01 -1.0672385659469772e+00 3.6984147519214111e-01 +277 -8.8028901289995187e-01 5.8075379122029680e-01 -5.0555689035944396e-01 +487 1.5229361655153211e+00 -4.3334638823410909e-01 -5.2025315373818937e-01 +202 1.1890248672755632e+00 -1.3103428543183313e+00 1.3877359082264291e+00 +139 -3.8593619396281981e-01 -4.1419081865118412e-01 4.8341157555249414e-01 +218 -1.2190042149414249e+00 8.6603581070857749e-01 5.3180226853912571e-01 +10 4.0346230429792890e-01 8.8022045895227152e-01 3.0611723210999553e-01 +64 1.0687583963535543e+00 -2.5590555538042992e-01 8.2852453062456832e-01 +40 -1.0543471069223134e+00 -7.9810717548135568e-01 1.4389073785681245e-01 +328 3.2979243925573831e-02 3.1076559402174242e-01 -1.6410904905031269e+00 +292 -6.3224783054646483e-01 -4.3704038413109603e-01 -2.2759444134328080e+00 +245 -4.7869651996764956e-01 1.4231085014444791e-01 -1.0109564296885869e+00 +148 -7.1011989912373741e-01 -6.8437374624235792e-01 -4.7084060341785217e-01 +435 -2.3710180935788738e-01 7.3150957873543554e-01 1.9569288343148944e-01 +301 -7.3626400316656140e-02 -1.2518892197053937e+00 6.4938262930099341e-02 +476 4.4522311443074564e-01 8.4413304640745324e-01 6.9180275295562699e-01 +310 -4.4579106235383259e-01 -1.4870237388818175e-01 -1.7519046471808755e+00 +137 1.0191269790481958e+00 -1.1871217736355175e+00 6.0687187776921336e-01 +434 -8.0977924479936902e-01 8.2445677967490594e-01 -7.2982619204505017e-01 +184 9.3329968718567657e-01 -7.8960961760367476e-01 -3.2387020805541877e-01 +5 -7.6591643318776403e-01 4.4567507028100856e-01 -5.1504861374485367e-01 +41 -6.0827814801341495e-01 1.0335818250945215e+00 -1.4262577781586459e+00 +410 5.1617643329833041e-01 -1.2505433325731774e-01 6.5548767709779598e-01 +418 7.4452116863445517e-01 5.5176595694257291e-01 4.8433486134467341e-01 +34 -1.0960797951083094e+00 -9.5559899011366922e-01 4.1467430632337771e-01 +67 -1.4762168791195980e+00 7.3902009632630203e-02 -9.8563314451155759e-01 +390 1.1040922756330935e+00 -1.0608530270906485e-01 -8.5480860400114822e-01 +125 1.1001683944330445e+00 2.5213959563273414e-01 -7.0907876564322847e-01 +105 9.3642884637919491e-02 3.2241122070134182e-01 3.4267503174724429e-01 +274 1.4805711826308454e+00 1.9591264275732104e-01 4.6208005550476272e-01 +314 3.3724005635036658e-01 -4.9228354871213487e-01 -5.9105855919176131e-01 +408 4.1789097671328662e-01 2.2054753884758851e-01 9.9409268338014201e-01 +142 1.3529751978153088e+00 8.8819247946851643e-01 -2.9699787225611667e-02 +25 -3.6747378202427655e-01 -1.6653943785151797e+00 2.1594786196965424e-01 +458 -7.3004682150577682e-01 -2.5761460079892318e-01 -7.5492049253862104e-01 +165 -2.6776300065898789e-01 -3.1428309412647404e-02 7.6464836175889062e-01 +421 -2.2112566002008222e-01 -8.0033416193571816e-01 7.4057822704117926e-01 +151 1.6510010513742961e+00 6.2880202489514836e-01 1.3109463507573997e+00 +162 8.6466591751463506e-01 1.2003096922919751e+00 1.6720745976940152e+00 +120 7.1544273833415639e-01 7.8605685992147967e-01 1.5756692842267452e+00 +448 9.4818399052933544e-01 2.0373333697562079e-01 1.1821449360296239e-01 +50 -7.4255028295716818e-01 3.2131856627302258e-01 7.0344624031236247e-01 +443 5.1965861871733798e-01 -1.0469002555669342e+00 4.3373559100868195e-02 +482 1.9661775056161916e+00 1.8911734358361203e+00 7.2949567046678088e-01 +407 1.8582263860937767e-01 -1.3051257268383373e-01 5.0987931207045945e-01 +100 -3.7775697318477114e-01 6.0919017017007682e-01 7.1809182324625254e-01 +99 -1.2684617496938173e+00 7.3671717137305515e-01 -8.1216571664258830e-01 +107 -2.8776644836089277e-01 5.0874100972210130e-02 -4.8277793530428115e-01 +480 -1.8051331679926971e-01 8.6563042329278228e-01 -5.8352716569019136e-01 +115 -1.0589943552297505e+00 -5.2550981762149152e-01 -1.7244688387853080e-01 +278 1.5768829958501078e+00 1.4428098110470169e+00 8.8216722790329116e-01 +206 -1.3653407453215169e+00 5.7341428096126357e-01 2.2629859809279146e-01 +4 4.2054817038258185e-01 -2.9390858515089308e-01 -1.7875237254421117e+00 +214 -1.0426854223671351e+00 -9.9898728143962490e-01 -1.9850479848636837e-01 +65 4.1792586017239108e-01 8.0186431881714215e-01 -2.0107060384389590e+00 +490 6.7355251805377303e-01 -2.0698786089395388e-01 -3.1564646838967253e-01 +230 -1.3855973935201399e-01 1.6134941051796734e+00 2.3723214232474421e-01 +234 1.9442134326447673e+00 -1.3805634063343805e-01 -9.8210270774821284e-01 +92 1.8063255781217027e-01 9.3716955232457000e-01 -1.9187798219061411e-01 +103 3.9559605419305116e-01 -8.7523159162324915e-01 -8.6993815784441930e-01 +129 1.2253789920819727e+00 2.8171983713246046e-01 -1.2180024131333584e+00 +483 9.6349992375661320e-01 -1.6348662648160852e+00 8.3712630375667085e-01 +110 8.0468512955471783e-01 -1.2623668571621947e+00 1.4617362498240638e+00 +126 -2.5741602043303030e-01 -2.5870568275485217e-01 -1.0282926023825125e+00 +276 7.0448925295125497e-01 -1.4486777483518087e-01 4.0589927727544634e-01 +294 4.9277474123671205e-01 1.0788251906341033e+00 1.0720476037391911e+00 +417 1.2134126298835348e+00 6.9341902173441838e-01 -6.5915650495314448e-01 +102 -9.4530772564542864e-01 3.5633646308084904e-01 2.1645216652503570e-02 +228 -3.1477177829390662e-01 -7.3015136189998553e-02 -1.3550661516185267e+00 +2 -1.5167590438599203e+00 3.2942906513575698e-01 -3.9430403043809092e-01 +222 -3.4853423639550507e-01 4.3402827204271471e-01 -8.9055344775375656e-01 +332 7.6671266929186610e-01 -4.2789189576138797e-01 2.2589706911206284e-01 +275 1.0091776783462640e+00 -2.3875723103898955e-01 9.0625273137588058e-01 +243 -2.4008164703199580e-01 2.4602229249214927e-01 -9.2542387373274426e-01 +394 -1.5496683613302659e-01 -1.4731622236607285e+00 4.3712483588631723e-02 +325 -9.9716991278750156e-01 9.0079916710328489e-01 6.1656781470423368e-02 +468 1.1367478364774437e+00 3.7268550263787792e-01 -1.9334998928228118e+00 +113 -6.1637943298580211e-01 -1.4259739417714792e-01 8.5880390205968704e-01 +47 1.4522907038923785e+00 -3.8138661441744320e-01 8.8902241399148096e-01 +474 -6.5326939744671464e-01 -2.9584216080544323e-01 -1.6703076347144621e-01 +343 -2.0865957540293453e-01 4.2320136734663144e-01 -5.2417372636564219e-01 +257 -1.6598412047016537e+00 3.9614126419385248e-01 6.2190463287430520e-01 +422 9.8621254947118736e-02 -4.5653326655140536e-01 -1.6959752095102018e-01 +317 8.1554926779727022e-01 -9.3952932101149422e-01 4.1213701483558629e-01 +322 9.7692194337623842e-02 7.2221211185210599e-03 1.4983319825497168e+00 +453 1.0112117753398511e+00 -1.6043121320019077e-01 -1.5109389287188097e+00 +82 -1.8245270960375951e-01 -1.7227940931260219e-01 9.4914460423273084e-01 +402 -1.3974163926710530e+00 1.0238276956317611e+00 -2.7116721725643461e-01 +201 3.8154565319070316e-01 6.1162789639306392e-01 5.3616806651343329e-01 +159 -5.5623509138788352e-01 -7.3506001159846490e-01 2.9669217335717424e-01 +239 -1.1703971851987414e+00 -2.5624748584715568e-01 1.9987978519039629e-01 +340 -1.1651635328367398e+00 1.4923285973929103e+00 -5.0638764373602618e-01 +246 4.6916366638116123e-02 3.7471219463751682e-01 -8.5595777185358435e-01 +268 3.9776335718715750e-01 -4.1326407010466332e-01 6.4132644428253849e-01 +238 -1.0102989663900468e+00 2.5145560602393102e-01 1.6537809300909093e-01 +183 9.6649446422314420e-02 -3.1320299584600791e-01 8.9787784698607254e-01 +393 -8.1709715097020719e-01 6.5173585509788723e-01 1.3340272254613436e-01 +177 9.2862946550951486e-01 -7.4734865012317631e-01 2.6370187436425798e-02 +97 4.0324698775550633e-01 -6.5060630846020162e-01 4.3381661619662121e-01 +16 9.2225588537666714e-01 5.0761227093429218e-01 2.8224038915514177e-01 +15 7.4631799122735776e-01 -5.1735298399747642e-01 1.0267699639319139e+00 +467 2.9233724948217432e-01 -1.7768548355681282e-01 9.7602334864839035e-01 +404 -1.5591392530118275e+00 6.9331308976828065e-01 -1.9156738913640683e-02 +190 -2.3293475783192552e-01 1.9804103372721136e+00 1.4400561196029799e-01 +429 -3.1240905856412571e-01 5.3399975662794008e-01 -8.3672459106253427e-01 +356 1.1813499076138427e-03 4.5712322524667531e-01 7.2569550209608535e-02 +459 -8.2536401218028255e-01 -5.1587534016495484e-01 -3.2429633054579987e-01 +140 1.4169132709847332e+00 -1.6948863471126016e-01 -5.4590188862129563e-01 +121 -8.0623019357608017e-02 4.3956025735145637e-01 -4.1230464603429395e-01 +76 1.2149513180720075e+00 3.0664283974167705e-01 -6.2206166881984115e-01 +24 -9.0953792569391767e-01 2.7208504534230199e-01 -5.7968255809907288e-01 +215 -3.6635366137979941e-01 4.9083544993599626e-01 5.4540399677247620e-01 +406 -2.8711421371139068e-01 9.8028410382686626e-01 -1.5688211456737056e+00 +495 -2.6064405757207798e-01 1.0014422650657693e+00 1.2195244915445839e-01 +256 5.1502433217852350e-01 2.1618101498582329e+00 -5.5671498574760148e-01 +348 1.5303758850601952e+00 1.3538700733088898e+00 -1.0404602147830582e+00 +18 8.7092721144608365e-01 8.8296303804909981e-01 4.7076145062566271e-01 +259 1.2579194534410862e+00 1.1275351076124240e+00 1.3255628670657002e-01 +261 -1.9457509303164215e+00 -5.7013962206489510e-01 6.5787967104563000e-02 +433 9.5143226323949670e-01 -1.9787864106930605e-01 2.1852616176467912e+00 +119 5.2387728877999162e-01 -7.5008900728698324e-01 1.0156553043596699e+00 +181 3.6547537534957092e-01 4.4856602347738611e-01 1.9502787843157898e-02 +392 1.8883706922750969e+00 1.0836617564317459e+00 6.8587165903540392e-01 +436 -7.5639783907079583e-01 -6.1811736982444421e-01 -2.2826839230281426e-01 +210 -4.5965909404278121e-01 -3.3285948977797364e-01 -2.8815683118847368e-01 +409 -8.9630394160430427e-01 1.2498156320615575e-01 -5.9486610361558201e-01 +437 -1.3458244785393264e-01 1.1611540390359226e-01 3.6707571520967769e-01 +114 -1.1780626363780731e+00 1.1424256338126497e+00 8.1898562672334474e-01 +431 3.9295632541408759e-01 -5.0466339464883803e-01 7.4701651109545830e-01 +296 -2.9562979314792992e-01 9.3794387166245374e-01 4.3821394647736267e-01 +477 -1.0332993738194893e+00 5.9732959339716152e-01 -1.6990304505644747e+00 +199 -1.0627414724922077e+00 3.6527741326574337e-01 -5.0076911469807539e-01 +31 1.1836258822972918e+00 -1.1805527709262840e+00 -1.0148440310730218e-01 +149 -9.7152762187442065e-01 -8.2689424175864179e-01 -9.8308725322137946e-01 +216 -2.6635793686817422e-01 -1.1249304826477751e+00 5.2675272099922754e-01 +425 -2.8287490221194594e-01 4.1086346332975782e-01 -5.6774387340250076e-01 +224 -6.3636066584070272e-01 3.8927738472590379e-01 -1.2043299828812322e+00 +352 -6.1634031766701480e-01 1.9344774717790295e-01 7.8374630494614250e-01 +289 -9.8440193523267117e-01 1.4471012647779624e+00 4.3922631035860088e-01 +455 -1.1942412759322272e+00 1.1300600257912083e+00 -4.7958784865825908e-02 +298 -8.4955866984285322e-01 1.8131854984076790e-01 -1.9010434504555735e+00 +42 1.1523609145851870e+00 1.3198909771653919e+00 -1.1943568765046571e+00 +80 2.0928302112510155e+00 -1.9281727715628849e-01 3.5879525261694012e-01 +127 1.0275071129063864e+00 -7.8560029105042173e-01 8.4680312545585235e-01 +232 3.2836195573764693e-01 1.5921754951459595e+00 -1.4889040346123832e+00 +368 -1.0143580013676627e+00 -6.3286772474382025e-01 5.9003271203631313e-01 +486 3.0052735920053437e-02 -7.5917073216074904e-01 -4.0707609210832352e-01 +209 8.3084043466989521e-01 -1.2819860426930157e-01 9.8450910112172252e-01 +152 1.4018503697498572e+00 -1.3364969077798206e+00 5.1589841760235022e-01 +353 5.3822763779176630e-01 -4.8322987719532096e-01 3.5634065895494110e-01 +361 6.8264929410893807e-02 -1.3682995245096907e+00 -4.9273501999153174e-01 +391 6.7065636846264776e-01 -2.7904582963633018e-01 -6.5303896626046076e-01 +464 7.4567031841775322e-01 1.8046977002555891e+00 -3.9159771733015164e-01 +497 -1.3856699033357778e+00 -9.3599081481125368e-01 1.8204759707532270e-01 +498 1.0568629143757213e+00 -6.8137997517450560e-02 -3.7037143049187105e-01 +264 -7.7894167957263005e-01 2.7383401106980504e-01 7.5098074183721675e-01 +265 1.9614235016832940e-01 -4.2322665725562197e-01 -1.6236881765469688e-01 +350 -6.3256317352651559e-01 -5.9660876051471468e-02 5.2317095757618959e-01 +144 -2.0800773378554721e-01 -1.5156540919629388e-01 -1.8814379829548375e-01 +17 8.2103760580927843e-01 -1.1053143150308307e+00 1.1843881143235824e-01 +441 9.9191589104231870e-01 -1.9479579195707514e-01 1.8130903870970541e+00 +266 -9.4957121369000017e-02 8.6997989048119007e-02 -1.5903074475142429e-01 +375 8.1973242957273296e-01 1.0075441532082390e+00 6.6277118207442265e-01 +351 -1.0694047025049973e+00 1.2185457298237026e-01 7.2731979237547140e-01 +254 -1.4178061472233576e+00 1.0044925984667965e+00 5.9999609355847139e-01 +29 4.7548776272319854e-01 1.5001558567759110e-01 7.4645778473548241e-01 +198 5.7218364285113010e-01 2.9196622753924861e-01 -1.2231490460337893e+00 +197 -1.4204377171882598e-01 2.1322055429678972e+00 3.5360172437812271e-01 +192 -4.3230000337254881e-01 8.1753260459826260e-01 -1.3961239427992276e+00 +220 9.2338173032465304e-02 7.2444278115958327e-01 4.3240465996750244e-02 +432 3.3837153168712325e-01 1.9757543957217949e-01 -3.2138599665961831e-01 +20 7.2972771576502227e-01 -7.1923547937920451e-01 3.8462300862783037e-02 +63 7.3459759072459618e-01 -2.1393390343408181e-01 1.4606085672716668e-01 +446 9.5489174587921177e-01 -2.2284752482645742e-01 -7.3147917056258960e-01 +172 -2.3233356067616504e+00 5.9696639792861073e-01 1.0311292046090428e+00 +405 -1.1779705391325133e+00 2.7846640825986735e-01 9.6440591359561623e-01 +323 1.2758508066094825e+00 1.1576865878083721e-02 1.3415986450967126e+00 +428 4.8021126796596170e-01 4.8003440312842205e-01 -4.1979524804611819e-02 +280 1.1723141734791545e+00 8.4290272518839332e-02 1.1240738308596074e+00 +54 8.2234236592018339e-02 6.9377897211693754e-02 4.6415665343815465e-01 +397 -2.4516753222359439e-01 -3.8647076314136586e-01 -3.1938187998240442e-01 +279 4.7475740365710301e-01 4.2033019401821775e-02 1.0791025172609856e+00 +134 4.6986570792330234e-01 7.5759398359663410e-01 1.3748348906115773e+00 +236 -1.4338534270949166e+00 6.5242359063738475e-01 -4.6879001422000049e-01 +493 -9.5795155221589912e-01 -9.3131490174346532e-01 5.2848598027407112e-01 +346 9.4017276609564226e-01 -1.4423054432512394e+00 -3.4883627652283825e-02 +295 -1.0211326704350645e+00 -1.5688283678435537e+00 2.2737881805456114e-01 +164 4.2933435120637192e-01 1.2908919636558716e+00 -1.8559649323965055e-01 +354 3.1232180266110654e-01 -3.3884174823706786e-01 2.0012570054806617e-01 +449 -4.1956545717722271e-01 8.5033185910749320e-01 -1.6923286514167504e+00 +185 -1.9847768794898153e-02 1.6093024328157031e+00 -3.4278049008935008e-01 +229 3.3354615877618454e-01 -2.1967770508754222e-01 -6.8288738508757751e-01 +135 -3.8598562184690355e-01 2.3459455181853697e-01 1.4591795655915993e-01 +211 -1.1858788850370010e+00 1.3960363241794649e+00 1.1390210005059993e+00 +81 1.3604301094625607e-02 1.2711357052370638e+00 1.3840699383718491e+00 +37 3.5025606454523878e-01 -1.0316562604143946e+00 2.4944393037279400e+00 +355 -4.2713554752038259e-02 1.6441819966987897e-01 -8.2550044716409909e-01 +141 8.1569462514471880e-01 -6.8558748209733145e-01 7.0575287639668483e-01 +122 3.6274405429300222e-01 -4.1985688325391463e-01 2.5223429679090231e-01 +327 5.2689568302324030e-01 -7.1530570005039407e-01 8.1591540939993761e-03 +386 5.2540176252260506e-01 -8.0891002493580211e-01 -2.1080798818740659e-01 +59 3.8008676468324715e-01 1.2302042558959829e+00 -1.2893140123247515e+00 +57 -1.2756375464672689e+00 7.7885421584605408e-01 9.3218921154320622e-01 +489 -4.8772350194378145e-02 1.1774319824237183e+00 -1.3413963962772402e+00 +326 -8.2073133946066312e-01 -1.2685275916429064e+00 -1.0253535003668284e+00 +359 -1.8991447869255085e+00 -1.2154594584519982e+00 -1.7832247863578221e-01 +349 6.4100123949028309e-02 -3.2723074072385872e-01 -1.5565659217165477e+00 +247 4.5734576435732799e-01 4.9511064545143885e-01 -1.5945768728559153e+00 +365 -5.7917383718454207e-01 -2.3494837692508375e+00 -1.5004840205862926e+00 +382 -1.0813649655944142e+00 4.1831946020927230e-01 2.9306887264755938e-01 +130 -5.7488571729114812e-01 -9.6638702807104448e-01 -1.0278487271582966e+00 +471 1.1085411185196428e+00 -5.2404573748396321e-01 9.9734211160337760e-01 +21 -2.3901903994255250e-01 9.3578484419611557e-02 -7.3719660959071831e-01 +499 -4.9906801820206043e-02 4.0499214176262377e-01 -2.9371307883695258e-01 +253 -7.8928864460108283e-01 3.3838305995790624e-01 7.1275694444227405e-02 +302 1.5254343639867396e-01 -2.7881674166920268e-02 9.3627888140226589e-01 +324 -1.1159492478288651e+00 7.0632546920242867e-01 2.5394407536700253e-01 +154 4.8736880051344117e-01 -1.3177717741071062e+00 -7.9660620460177323e-01 +284 1.7716036485389025e-01 -3.6539348914929748e-01 -4.6941135291661629e-01 +161 -2.7479275242316997e-01 7.6982156884799513e-01 -5.7088165723862649e-01 +112 2.7023059482372042e-01 2.0487127767495705e-01 -4.9350658197380731e-01 +39 -1.6840134362063963e-01 -2.0596641915022665e-01 1.2622422574022685e+00 +269 -1.4448376822412348e-01 4.2047192520573229e-01 -1.5751711248887881e+00 +470 -9.0198936075875380e-01 -1.0035762705605118e-01 1.1469701649179411e+00 +84 -3.7165102348228596e-01 1.5718083932531206e+00 1.8715295090631173e-01 +381 6.6740577340943863e-01 -1.9432536761932276e-01 -1.2757754863002870e+00 +416 7.2118119300841677e-01 8.6813375765446710e-01 -8.2350198387929519e-01 +182 3.3694648494832763e-01 -6.5830649973844163e-02 7.0076361524788766e-01 +347 -2.4949061953800500e-01 -1.1432286442922379e+00 -4.5757988288631407e-01 +380 -4.7143472726668367e-01 -2.9180051952103941e-01 6.0581680882348110e-01 +19 7.3007216948068054e-02 9.4947888518620716e-01 3.4627576178512598e-01 +430 -2.2320112834958328e-01 -3.8559102989803251e-01 1.0427665572858709e+00 +212 2.0170777345036919e-01 -9.9332505765821755e-01 1.0550787824425254e+00 +479 -7.7910620356048310e-01 -3.4759422268929079e-02 -5.8756871125828891e-01 +217 -7.0999315500035393e-04 -1.4874035841198494e-01 -1.1389898361525996e+00 +147 3.3953282916732841e-01 1.0503362153417393e+00 8.8554338624429496e-01 +13 1.4952012032076418e+00 -1.3492024227588162e-01 8.6834761707295621e-02 +170 -7.5230462228731629e-02 1.9875829136564169e-01 3.8512887113920530e-01 +204 -3.1459152727076800e-01 -7.2066080044499392e-01 -7.5277710665622377e-01 +306 8.0529112138128323e-01 5.8633344712571456e-01 -1.8256367575393391e+00 +414 -1.7678147014996259e+00 -7.1706970804552028e-01 6.0614094017430153e-01 +79 1.6303375369704216e+00 -9.6446702691566244e-01 1.7014099837302679e+00 +116 -1.7231587507489068e+00 -2.2374070614774770e+00 1.0442058418221465e+00 +231 -9.2546402309298947e-01 3.2157716287919585e-01 -6.2797312032694141e-01 +171 1.4243635122212095e+00 -3.4034411127116748e-01 2.1060050313379719e+00 +273 1.0777993506600285e+00 -1.7160435918146213e+00 1.0194335249558832e+00 +260 1.4544392536719453e+00 9.3765863648494707e-01 1.9642995061847701e+00 +43 -1.1326443879098980e+00 1.4846909715454837e-01 1.6874301063514463e+00 +208 -1.1234489793683757e+00 -1.0408587064067447e-01 -4.8386417041968832e-01 +226 6.0458834484750512e-01 -4.5998597100022531e-01 -4.1420588246526679e-01 +370 -2.5264443636161833e-02 2.2888129565845829e-02 -7.5123334633027034e-02 +85 8.9124431006375637e-01 1.2150234901900336e+00 -1.3794080039677503e+00 +213 6.8750004752856542e-01 1.7643443473184617e-01 -7.6039731517372366e-01 +299 1.1166507011383160e+00 -6.9342398354435130e-03 4.0031150060326554e-01 +249 1.6676259701674601e+00 -1.2916011404415280e+00 8.3081388251616040e-02 +258 -3.3338543070706111e-01 -5.9677208925291603e-01 1.5474505568531705e-01 +388 3.3338877926510010e-02 3.6534261356710357e-01 -9.3163626937108668e-01 +91 -1.0436539497197659e+00 -3.6206368573074071e-01 -3.9406149981573330e-01 +415 1.8022253921012549e-01 -2.5361248238828202e+00 7.8761564433010600e-01 +27 1.6681493439613866e+00 -6.3832374162264238e-01 5.5825898158707521e-01 +465 -3.3883292906124979e-01 -1.9199928938047977e+00 -1.8916637827626086e-02 +72 -7.0256791239588934e-01 -1.3631374858756479e-01 1.1539466869530803e+00 +58 -9.7431680335045678e-02 -1.0635351953490649e-01 -4.5168665276313896e-01 +88 5.2937320884954953e-01 -1.1749454649084838e+00 1.2744645330784524e-01 +6 -1.1593774469007843e+00 5.1413980407296589e-01 1.2944389470552302e+00 +75 5.7374690805841033e-01 7.8433587872715163e-02 -3.9368611836917572e-01 +22 -9.6996881290452630e-01 1.2965746977075312e+00 -1.5394575986278033e-01 +128 -6.4070276272082638e-01 2.2708380115440285e-01 -1.6142126045669323e+00 +193 5.7443781554989515e-01 -1.2458447329459237e+00 -9.3796775534017041e-01 +389 6.7276417854677451e-01 -2.9571653479618748e-01 -2.4423872850138906e-01 +241 -1.4102001294916395e-02 -9.9059498112109945e-01 -8.4827835518272399e-01 +14 1.0515231184651945e+00 4.5617222115757200e-01 -5.2911246318135385e-01 +307 5.0028759749137040e-03 -5.0699437336696396e-01 -2.5790615969461578e-01 +401 3.9207473498457289e-02 -9.2058641117610335e-02 -1.3689269955592848e-01 +248 1.5980225324156891e-01 -4.1600725109692227e-01 4.1253240562945254e-01 +335 5.6526042010051392e-01 -1.0563866873458263e+00 2.2963431232103770e-01 +281 4.7335967523683825e-01 -9.8764893385752195e-01 1.3275577965292436e+00 +33 9.5713349527393091e-02 -6.7578402785937589e-02 1.2308478723868863e+00 +221 -1.2080117435798665e+00 -2.2142477880517361e-01 -7.4060132361069042e-01 +251 5.1352069062594478e-02 -4.7173153686079722e-01 1.3645828375870801e+00 +138 -9.8931419992230929e-01 -5.6403083699472267e-01 4.8437720371021081e-01 +73 -8.7238230525929461e-01 2.2619668651197614e-01 -3.2904255863286136e-01 +237 1.5966476021876643e+00 -1.0734521639966819e+00 -5.7008225474518526e-01 +77 -6.5731386120913948e-01 -1.3672574981662913e-01 3.4397972232069346e-01 +339 6.8164227902965080e-01 -8.7654828372118265e-01 -9.2289632523091991e-01 +69 -1.0710495228647499e+00 -2.2798359247984892e-01 -1.4017813863798740e+00 +150 1.4728554201464288e+00 1.6873571351133543e-01 -4.9418642333439719e-02 +219 3.5347912349947574e-01 1.9808724875609746e-01 -5.0625815831733678e-01 +9 6.3426493841071574e-01 2.5658018877632760e-01 4.7953937763858034e-01 +3 -1.2144659411870629e+00 8.8297859772359033e-01 -2.6732917639533704e-01 +93 3.3822789154655764e-01 8.1143107440094409e-01 -2.7263548606070248e-01 +68 1.6351351046383883e-01 5.8445604848527588e-01 1.2062643207337951e+00 +35 1.6550671586466750e-02 1.6790869037398232e-01 2.5947900830558479e-02 +174 1.4403688502275100e+00 1.4476094634256031e+00 -1.0038411182890872e+00 +369 -7.9303772394565375e-01 -1.1303432398125628e+00 -1.5457440975201582e+00 +469 -5.5239153419630294e-01 -4.7075634498045837e-01 5.0539291079888571e-01 +270 5.0351525849727374e-01 1.3716919044917866e+00 2.8157430421583601e-01 +196 -2.2101193763774998e-01 9.4257812877032954e-01 -1.2881024224381614e+00 +235 -3.7410168233289759e-01 1.9712488864630789e-01 4.3505985658493368e-01 +104 1.0770774810232915e+00 -7.7420116923795979e-01 6.4885799952777634e-01 +363 6.7513909705285891e-01 2.0186757605257277e-01 6.2260156794788402e-01 +440 -2.7563401138205812e-01 4.0196589304635166e-01 6.8696509786942431e-02 +271 3.5486339796858996e-01 -1.0482634846478769e+00 1.0693870635001128e+00 +385 2.0653637543135839e-01 1.6251902525248125e+00 -1.0240800582063148e+00 +367 1.2090890730479817e+00 7.7304993739281713e-01 -9.1196492155951403e-01 +8 1.5650406952874099e-01 1.4761853226272020e-01 7.1667065222651671e-01 +445 -8.1712119890107360e-01 5.0169175756271378e-01 6.3236875667481124e-02 +95 7.1388432342661989e-01 -2.6058252368101411e-02 -1.0159428151424379e+00 +227 -2.1897046900910261e-01 2.4492515107534649e-01 2.2679621024062299e-01 +45 5.0120245022687604e-01 -1.1380921868404339e+00 7.8232214243213327e-01 +62 5.7973338245234629e-01 -7.9117819757367913e-01 -5.4327640325878901e-01 +309 5.3715909018265540e-01 -1.7844975395461696e-01 -1.5521878040430610e+00 +70 -1.3649193486754410e-03 -1.5242800010205164e+00 1.6225001176581824e+00 +285 -1.5639729724408871e+00 1.4626366106935738e+00 -1.2286649953661322e+00 +387 -1.3226131489884976e+00 -1.0695489941103238e+00 -1.4911056977700106e+00 +484 -1.5087954881419843e+00 -2.3407968100714568e-01 8.9471716161806181e-01 +98 3.0624993702155973e-01 -1.5934008419723134e-01 -1.0700290072035785e+00 +282 -1.1678279208732874e+00 8.8816716100523774e-01 -3.7594379985472404e-01 +203 -1.2339287833422024e+00 -1.0851718286318821e+00 -3.5581216293468138e-02 +189 -2.5647410293058537e-01 -3.6970804452537526e-01 -2.7009745024499721e-01 +267 -2.3687566231483211e-02 5.4572876490146272e-01 1.2664988400691950e+00 +155 1.7966821085178111e-01 -1.4254017034472058e-01 -1.0614594824352175e+00 +313 -4.0833555690731410e-02 -4.8193546027639250e-01 -4.9602679807507655e-02 +250 4.3395781720710452e-01 9.1543705256636054e-01 -6.1780594432179192e-01 +49 -5.8496932778818223e-01 2.0845066341835794e-01 -4.5660091846264866e-01 +111 -4.5577164923909808e-01 6.7687347516731056e-01 1.6901306317755600e+00 +124 2.3017035971304120e-01 1.2116381200880159e-02 -1.0715278739263430e+00 +488 1.1047027896127255e+00 -1.2726762145955062e+00 7.7913777050672761e-01 +48 -4.0669146183799126e-01 -1.0181831306551499e+00 6.3005463620771884e-01 +123 -1.2387342693749222e-01 -4.5460712390743935e-01 -5.6241811130968811e-01 +423 1.5051226831159246e+00 -1.0959205280256621e+00 3.5512567969767117e-01 +329 1.5695087401093555e-01 -4.0810545929224507e-01 1.5430948869435961e+00 +334 -1.0908322951892016e+00 -5.4577269465148259e-01 -6.7521769754195848e-01 +146 4.4361993166914260e-01 4.1962079818012665e-01 -3.9049661615798353e-01 +500 -3.0319085884539942e-01 7.6039240701443311e-01 2.0836797720615632e+00 +46 -3.9431430053902639e-01 3.7259615958614579e-02 -1.6080049457594121e+00 +374 9.2250275913940816e-01 -5.4107808677407720e-01 6.5542912197165987e-02 +52 7.3216124676172201e-01 9.4572980131871298e-01 -1.2696251833719743e+00 +466 1.5044833940669236e+00 -1.8483350803538756e+00 9.5057050040256286e-01 +272 -4.0011978947412463e-01 2.0429884556820119e-01 5.4991808303431688e-01 +331 5.7814259377466726e-01 1.7044411336854475e+00 -7.2986308719737536e-01 +12 6.8240059668147224e-01 8.7756006768431916e-01 -1.7546792723746987e+00 +178 -1.1529369201979585e+00 -3.9576843637993819e-01 4.1654001054549866e-01 +376 -1.3678465511836193e+00 -1.5404423718061540e+00 -8.9187926122069050e-01 +117 -1.3804354656475164e+00 -7.9075263667417661e-01 -3.6776627245391275e-01 +419 1.9706999335859632e-01 -1.1815264434314889e+00 1.6458873301525292e-01 +379 2.6784097653047051e-01 3.8806722276897926e-01 4.0603233211791162e-01 +53 1.0521966172519035e+00 5.1164934479578683e-01 9.8577725800730365e-01 +28 1.0129347774638686e+00 1.1058165761432928e+00 -3.9034581257989903e-01 +300 -1.4876024382598509e+00 -6.2467982655378396e-01 1.3535210035045362e+00 +83 9.7907832581926901e-01 1.4855763621624507e+00 4.1007013403839504e-01 +304 -1.8963384707907098e+00 5.2731582964002444e-01 1.0962854464287259e+00 +51 8.5928138726119452e-01 -1.6162178311396377e-01 3.2746315986045632e-01 +180 -3.4136546641226267e-01 1.2771151944969144e+00 -3.9578085701206223e-01 +60 -1.7295103304379962e+00 -9.9492157200179920e-01 1.2224650147307308e+00 +255 5.0740556300071860e-01 -6.6892801585963790e-01 -4.4506165343889975e-01 +336 3.8821455708543523e-01 7.4853146108739210e-01 1.0393955338521590e+00 +74 -8.5185557539809709e-01 5.0099005012093123e-01 6.1187012870886726e-01 +11 -4.8598509694234203e-02 -9.7638648911006976e-01 3.6444261502684167e-01 +106 -8.3362253193144206e-02 -9.2846276284357510e-01 -2.0625632391587234e-01 +342 -1.1850581603543699e+00 -4.6587013939418070e-01 -2.5534356631266192e-01 +366 1.8044603030107276e-01 1.2857436498573065e+00 -4.9002876775305132e-01 +153 5.9355527141792742e-02 8.5309993046714749e-01 1.2601655126485285e+00 +384 -3.3199740732000493e-02 -1.1586262754841152e+00 2.7022536481319620e-01 +444 1.4366137360637837e-01 7.4777392856310121e-01 -1.3874143079892032e-01 +169 -2.2106828869911426e-02 4.3869453276997300e-01 -8.6050040149769946e-01 +312 -9.5175409360636343e-01 -7.9143766981298624e-01 -8.3109524929616485e-01 +131 -1.2661930440833327e-01 4.9560114120296378e-01 1.2481373975929652e-01 +290 4.7988720115251880e-03 4.3307801179133432e-01 7.2537453656012302e-02 +240 -1.4417217340859769e+00 1.4357683004122099e+00 1.4379544254488796e-01 +403 9.8034468727423985e-01 -2.0429774540476020e-01 -1.4454160823908524e-01 +438 1.1944593880989134e+00 2.3483551676455661e+00 1.9984542691081373e+00 +420 1.3486549938776343e-01 -1.0783938772052266e+00 2.4823645088293936e-01 +175 1.6188020186225376e+00 -1.2786027961604105e+00 1.5779664705358573e-01 +305 7.6304434006850930e-01 -1.0609104653684724e+00 -1.3992599279449225e+00 +341 -5.0986549858189378e-01 9.7345649143358179e-02 -5.4583627317992767e-01 +291 1.4937985447982780e+00 1.1345276617898410e-01 1.4735185581275405e+00 +372 2.7438262099508215e-01 2.3642499432513167e-01 2.0103126185436837e-01 +293 -2.0812456222423235e+00 1.2585017395884830e+00 -1.9872753884412903e-01 +461 -1.7366155414350635e+00 6.7563297134023181e-01 -3.0241597324899727e-01 +263 -9.9912758612453856e-01 -1.4606803538340738e+00 -4.8347668759554979e-01 +473 1.5452042518079840e+00 1.3194414166855677e+00 -1.4200655529990689e+00 +166 -1.4143951087621034e-01 -1.1527398628151918e-01 -2.0324403247706951e-01 +132 1.6628716981291343e+00 -2.6751309910688231e-02 -1.1291183234894089e+00 +32 -2.3270952903472897e-01 2.1018074582476372e+00 1.1203402946623044e+00 +475 -1.2604994295453433e+00 -9.5339439518226154e-01 3.3662881048301792e-02 +283 1.2749816341052314e+00 4.7341406662300863e-02 8.5345288522412766e-01 +205 9.6825352209774937e-02 -1.0389613158303228e+00 -5.4505460161674724e-01 +158 8.8743698904591217e-01 1.0689060843560156e+00 6.1104406355038210e-01 +1 5.8273461256327774e-01 4.6658417699512433e-01 7.3964607391058224e-01 +485 4.4170048227791719e-01 -2.8581555293721217e-01 -1.0141724005249320e+00 +378 6.6654429040499424e-02 -1.8224880226392848e+00 1.2128685020610477e+00 +71 -9.1996605782626056e-02 -2.2291664206826806e-01 -1.2402752353304469e+00 +320 -9.5597854323421563e-02 -8.6852053155856812e-01 3.5066557017928385e-01 +481 7.9532304801009490e-01 -9.4180364698072971e-01 1.2495155405965916e-02 +318 -4.1450336396091869e-01 3.4120074122917260e-01 7.3720013366972947e-01 +496 -6.2393347120986375e-01 1.0494054390993381e+00 -1.0590359239552802e+00 +319 -9.5320962685676391e-01 9.2021659866276262e-01 5.5763202369068265e-01 +338 9.5180850251473562e-02 7.4581412234581979e-02 1.6562396473566801e+00 +358 -1.2039319191565336e+00 9.9635011716776112e-01 3.7776599320072252e-01 +225 -2.2878377680357529e-02 5.9393376646738183e-01 -1.7855655501046659e+00 +55 -1.2658412487783444e+00 8.3827650617277571e-01 3.7229167676011687e-01 +362 -1.1190412417889151e+00 -4.1093870066191052e-01 -5.5943417408569930e-02 +36 -1.1944064170110538e+00 5.2834231151049005e-01 -2.5661926163189262e-02 +133 -3.4046853819783990e-01 8.7037698795660379e-01 2.6480748394474063e-01 +412 -8.2433971673189854e-01 -2.4364204997081215e-01 3.2182546651866395e-01 +89 1.2836300411162869e+00 -1.0534639266932924e+00 1.7273414295686953e+00 +38 -5.4018176537409834e-01 1.1189891674084445e+00 -5.4949279328730405e-01 +337 2.0680174457636453e+00 6.8756290663232345e-01 -5.3885707707990127e-01 +233 -1.1580426595635346e-01 1.5352867360847791e+00 1.8920809100075830e-02 +442 -5.2273629379374242e-01 -4.7573534425197805e-01 3.3349171376798270e-01 +143 -6.4456717536444386e-01 -8.2221860127843815e-01 -3.1619033462829965e-01 +194 4.6000888686458724e-01 2.4868203858229221e-01 -1.0844456124091726e+00 +308 7.0412401782623568e-01 1.4705120558853640e-01 -1.6984333842169479e+00 +286 -7.4825969157579242e-01 1.7277684761952672e+00 -4.8658995664543186e-01 +61 -1.4087152482721139e+00 -1.9786675343505181e-01 -8.3049863139435698e-01 +426 -5.9317510584759559e-01 -3.1176204329742879e-01 9.7102624547089234e-01 +450 2.9660411649227686e-01 -1.0106432265344207e+00 -8.0608626908093450e-01 +188 -4.5857896465809017e-01 8.3781782180488956e-02 1.6679261825519407e+00 +94 -2.5105865768429703e-01 -1.0277678550758340e+00 2.0110948522283595e-01 +252 -2.6250057461969262e-01 -8.3779492646801812e-01 -1.2443616941843418e+00 +321 -1.3849227082743394e+00 -7.9961814140752485e-01 -5.2758719721869440e-01 +156 9.7248559724229044e-01 1.4856613149426096e-01 -1.0762319296143268e+00 +167 4.8758255885458768e-01 3.7938735168685944e-01 -8.2720329905212353e-01 +330 4.8147102008722625e-01 -2.9945144880586022e-01 -7.3225876236181275e-01 +195 1.6483881807209144e+00 -1.9598861592898009e-01 -6.2914422221089158e-02 +78 2.3726384124165131e-01 2.7514362192855252e-01 1.7571172900747967e-01 +157 -2.1865090243933563e+00 3.7632441115528098e-01 7.7333806476534650e-01 +373 9.8884980347773899e-01 3.4121263358683873e-01 -3.3626353210018556e-01 +56 -5.1874451216553419e-01 5.0889073330236878e-01 -7.4130187216438104e-01 +315 1.5052362221906064e+00 -6.9840962964633502e-01 -1.5488907100876634e-01 +478 1.1082301092586995e+00 2.9770971389874379e-01 -5.4580262091212584e-01 +109 9.4396405787734605e-01 4.9318782477478235e-01 1.2284569230572757e+00 +357 -1.2371693160029509e+00 4.1376978558912775e-01 3.3529522630256764e-01 +454 -4.4342104600414733e-01 -3.5633346291025164e-01 -2.1131375082322554e-01 +86 -2.6274074185542590e-01 -2.7912975828127135e-01 -3.4564526880694488e-02 +262 -2.0457328043953218e-01 -1.0549970010682790e+00 -8.7569945910877856e-02 +160 1.2508565962389259e-01 -1.1049367732134203e+00 -4.1414673901133031e-01 +168 -5.4833844765552298e-01 9.1122623641564449e-01 -8.1466354261018392e-01 +145 1.9424847461468013e+00 2.4717259671440775e-01 -8.1993106446423478e-02 +400 -7.3927429735196926e-01 9.6278828542903949e-01 9.8355595468926471e-01 +395 -1.7616642510587566e+00 -4.3839255400156163e-01 -4.3538389834393521e-01 +297 -8.1651466743971568e-01 1.9480772762641770e-02 -2.5090574319554337e-01 +207 9.9594630394692474e-01 -5.5333584932915503e-01 -8.1672262386449701e-02 +460 3.8863838706865678e-01 -1.9332061145329088e-01 7.5599739666291188e-01 +44 4.9322334356812642e-01 5.4097595609480897e-01 1.2096517945019982e+00 +377 -2.3588544095100208e-02 4.2843373407529362e-01 -8.1372583759538197e-01 +411 -7.0187880935114388e-01 -8.8403807864596529e-01 3.6139298123719504e-01 +396 -6.1324863673452068e-01 -5.8579142070009704e-01 -1.6980414017487730e+00 +424 -1.4405372913769463e+00 -1.2161267905238037e-01 -7.1275775203655271e-03 +66 -2.2455608800065441e-01 -5.5194985983545303e-02 -2.9031971555487707e-01 +371 2.8693892522161785e-01 -1.3942754264578394e-01 4.1638095135795372e-01 +186 -2.5542578648985415e-01 -2.7435394726950046e-01 1.6931522427410683e+00 +413 5.6007135922818607e-01 1.2189064363493711e-01 -7.5271223366515216e-01 diff --git a/examples/USER/uef/nvt_uniaxial/in.nvt_uniaxial b/examples/USER/uef/nvt_uniaxial/in.nvt_uniaxial new file mode 100644 index 0000000000000000000000000000000000000000..613f46935cba579aa52fba7f6cfaed40a932ef3a --- /dev/null +++ b/examples/USER/uef/nvt_uniaxial/in.nvt_uniaxial @@ -0,0 +1,28 @@ +# uniaxial NVT deformation of WCA fluid + +units lj +atom_style atomic + + +pair_style lj/cut 1.122562 +read_data data.wca +pair_coeff 1 1 1.0 1.0 +pair_modify shift yes + +neighbor 0.5 bin +neigh_modify delay 0 + +change_box all triclinic + +fix 1 all nvt/uef temp 0.722 0.722 0.5 erate -0.5 -0.5 + +fix 2 all momentum 100 linear 1 1 1 + +#dump 1 all atom 25 dump.lammpstrj + +#dump 2 all cfg/uef 25 dump.*.cfg mass type xs ys zs + +thermo_style custom step c_1_press[1] c_1_press[2] c_1_press[3] + +thermo 50 +run 10000 diff --git a/examples/USER/uef/nvt_uniaxial/log.30Jul16.npt_uniaxial.g++.1 b/examples/USER/uef/nvt_uniaxial/log.30Jul16.npt_uniaxial.g++.1 new file mode 100644 index 0000000000000000000000000000000000000000..1d6530ff46399e871165848d948b8ffeabe77639 --- /dev/null +++ b/examples/USER/uef/nvt_uniaxial/log.30Jul16.npt_uniaxial.g++.1 @@ -0,0 +1,273 @@ +LAMMPS (30 Jul 2016) +# uniaxial NVT deformation of WCA fluid + +units lj +atom_style atomic + + +pair_style lj/cut 1.122562 +read_data data.wca + orthogonal box = (0 0 0) to (8.39798 8.39798 8.39798) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities +pair_coeff 1 1 1.0 1.0 +pair_modify shift yes + +neighbor 0.5 bin +neigh_modify delay 0 + +change_box all triclinic + triclinic box = (0 0 0) to (8.39798 8.39798 8.39798) with tilt (0 0 0) + +fix 1 all nvt/uef temp 0.722 0.722 0.5 erate -0.5 -0.5 + +fix 2 all momentum 100 linear 1 1 1 + +#dump 1 all atom 25 dump.lammpstrj + +#dump 2 all cfg/uef 25 dump.*.cfg mass type xs ys zs + +thermo_style custom step c_1_press[1] c_1_press[2] c_1_press[3] + +thermo 50 +run 10000 +Neighbor list info ... + 1 neighbor list requests + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 1.62256 + ghost atom cutoff = 1.62256 + binsize = 0.811281 -> bins = 11 11 11 +Memory usage per processor = 2.40217 Mbytes +Step 1_press[ 1_press[ 1_press[ + 0 6.3937851 7.0436438 6.4461087 + 50 10.369902 10.999889 6.5437384 + 100 12.411384 13.145871 7.8892802 + 150 12.88182 12.114068 7.5155182 + 200 10.375571 10.979773 6.5624056 + 250 10.158901 10.251273 5.4525068 + 300 10.011314 9.8371382 5.4031393 + 350 9.4890008 9.7992108 5.054963 + 400 9.1715116 9.2647886 4.9600208 + 450 9.8495961 9.3353483 4.986786 + 500 9.5903809 8.576173 4.8252116 + 550 8.8057509 9.7152078 4.9089022 + 600 8.9743682 10.031277 4.8924072 + 650 10.233852 9.3059527 5.1977058 + 700 9.2361906 9.6439971 5.0923763 + 750 10.449751 9.5911465 5.2548714 + 800 9.8366857 9.9873885 4.9456956 + 850 10.266351 9.9620134 5.0602713 + 900 9.6325813 9.3910946 5.1466624 + 950 9.1911919 9.1519006 4.8275345 + 1000 9.2871712 9.8508501 5.2674099 + 1050 9.7052035 10.291793 5.160359 + 1100 9.9425552 10.361827 5.5520484 + 1150 10.377563 10.26588 5.5997436 + 1200 9.6368269 10.354413 5.4137873 + 1250 9.2071055 9.1706334 4.9800411 + 1300 9.7140516 8.7257777 4.8536943 + 1350 10.145983 9.8247797 4.8921813 + 1400 9.1998975 9.6935675 5.2269871 + 1450 9.4838136 8.9035726 4.6867121 + 1500 9.066389 9.811658 4.8875316 + 1550 10.007083 9.8946118 5.204609 + 1600 9.722137 9.9291588 5.326712 + 1650 9.7424614 9.6995966 5.3577819 + 1700 9.7185135 9.5922931 5.385856 + 1750 9.6368481 8.1414594 5.0046079 + 1800 9.8065782 9.6798036 4.92473 + 1850 9.0463737 10.024205 5.6495695 + 1900 9.0774484 10.527582 5.0363426 + 1950 9.1691461 10.049703 4.8517514 + 2000 9.7619602 10.049532 5.2088038 + 2050 9.9203348 9.8056395 5.7699852 + 2100 9.1455665 9.5864018 5.1410542 + 2150 8.8501135 9.7917307 5.141824 + 2200 9.1433685 9.8168548 5.1742441 + 2250 9.3248968 10.454532 5.5456356 + 2300 10.210505 9.361499 5.0935226 + 2350 9.5041186 9.598986 5.2451005 + 2400 8.968896 9.2811921 4.7799868 + 2450 9.8201159 10.133892 4.9981817 + 2500 9.4421084 9.7875766 5.4124809 + 2550 9.6410643 9.9148309 5.0603288 + 2600 9.3810676 9.5346849 5.3233836 + 2650 9.2340337 8.7233538 5.0361302 + 2700 9.405597 9.7848488 4.7537042 + 2750 9.9447412 9.2366502 4.9736459 + 2800 10.189443 9.452684 5.624362 + 2850 9.6680124 9.0941543 5.0101469 + 2900 8.4350889 9.1595018 4.7706866 + 2950 9.0056117 9.3498593 4.7655963 + 3000 9.4795416 9.7400747 5.4705868 + 3050 9.6605264 9.4558374 5.1240166 + 3100 9.681451 9.7966554 5.3174458 + 3150 9.7887528 9.7371194 4.9349103 + 3200 9.9720054 9.5592538 5.2306417 + 3250 10.185023 9.9436037 5.4127312 + 3300 9.9670676 9.6069307 5.026261 + 3350 9.0090411 9.5975249 4.8881019 + 3400 9.6535707 9.748683 4.9933873 + 3450 9.7774977 9.7570511 4.8512619 + 3500 9.7250053 10.36386 5.4057249 + 3550 9.567788 9.773413 5.3936671 + 3600 9.2094148 9.0211247 5.2328675 + 3650 9.3512098 9.73407 4.576624 + 3700 9.159074 9.2611591 5.2996448 + 3750 9.4772798 8.9792211 5.1007079 + 3800 9.3898357 9.1150609 5.2126508 + 3850 9.2466312 9.1460651 4.867472 + 3900 9.9316993 9.3061137 5.1219265 + 3950 9.2550913 9.780254 5.371885 + 4000 10.005356 9.7328972 5.2535791 + 4050 9.5228242 9.5134113 5.4181393 + 4100 9.576808 10.082425 5.1272491 + 4150 10.20265 9.6667058 5.529118 + 4200 9.9443671 10.09427 5.6163734 + 4250 9.4956875 9.9462818 5.0820085 + 4300 10.350144 10.003702 5.1621505 + 4350 10.119486 9.8691507 5.4913457 + 4400 9.4991604 10.516185 5.2512264 + 4450 9.0812854 9.2835603 5.1695714 + 4500 9.7538478 8.5298834 4.5954607 + 4550 9.8920394 9.3581299 5.202587 + 4600 9.2694921 9.3338291 5.201958 + 4650 10.925818 9.5062049 4.8694531 + 4700 11.020014 10.130224 5.582409 + 4750 9.5005142 9.3571561 5.456739 + 4800 9.6670147 9.6628702 5.0451252 + 4850 9.134147 9.1308788 4.7950594 + 4900 9.7466206 8.6171443 4.8716275 + 4950 9.0397505 9.1996036 5.2010502 + 5000 9.6898652 9.8914655 5.3959279 + 5050 10.06771 9.7523891 5.3690408 + 5100 10.000963 9.6279379 5.4077384 + 5150 9.8686159 10.179702 5.0686824 + 5200 9.8866247 9.725152 5.4350049 + 5250 9.2068346 10.214424 5.3187713 + 5300 9.713992 9.8069045 5.496359 + 5350 9.423852 9.364085 5.2144606 + 5400 9.4350241 9.5584633 5.0339001 + 5450 10.555124 10.784922 5.1938072 + 5500 9.4147344 10.33187 5.4360602 + 5550 9.8514653 9.6575827 5.4959779 + 5600 9.3138107 9.6592624 4.941387 + 5650 9.1224809 8.7112257 5.0435936 + 5700 8.8289158 10.749686 4.8916132 + 5750 9.7200279 10.030606 5.2033161 + 5800 9.8439873 9.6289015 5.5131934 + 5850 9.6257294 9.4128988 4.9196038 + 5900 9.7490214 9.5776313 5.0301815 + 5950 9.1430855 10.108944 5.1406243 + 6000 9.3358644 9.5633737 4.9787073 + 6050 9.4432774 8.9464304 5.1466052 + 6100 8.8878373 9.5048946 4.9190238 + 6150 9.6451898 9.2419823 5.0159841 + 6200 9.5042173 8.9414307 5.2634247 + 6250 9.0896505 9.7230651 5.3340322 + 6300 8.8100599 8.8781352 5.4117914 + 6350 9.3104601 9.0233294 5.3136432 + 6400 9.368101 9.6387362 4.7833216 + 6450 10.334343 9.8384149 5.3606204 + 6500 9.8824036 10.022627 6.0857086 + 6550 9.7034443 10.026765 5.17604 + 6600 9.3757845 9.899268 5.2301359 + 6650 10.540821 10.4343 5.5287065 + 6700 9.6317649 9.8923579 5.6045768 + 6750 9.5982772 10.07897 5.1221451 + 6800 10.239883 10.189967 5.3167447 + 6850 10.017271 9.7680902 5.229621 + 6900 9.6200416 10.129301 5.1998759 + 6950 9.0361417 8.923798 5.1652612 + 7000 9.3153521 9.063054 4.6860773 + 7050 8.6434091 9.0363436 4.7811975 + 7100 9.4955395 9.3830541 5.022538 + 7150 9.3392402 9.1847119 5.1544622 + 7200 9.4676321 9.8370036 4.8854442 + 7250 9.5115882 10.350324 4.9780525 + 7300 9.6025583 9.6247917 5.473794 + 7350 9.8919524 10.049446 4.9816931 + 7400 9.6814319 9.9410894 5.265078 + 7450 9.4130955 10.191436 5.2531256 + 7500 9.8114668 8.8461635 5.0562894 + 7550 10.321567 9.4730124 5.2043655 + 7600 9.5059024 9.8330367 5.0749721 + 7650 10.067084 10.606423 5.5598818 + 7700 10.896159 10.084281 5.5159718 + 7750 9.754306 10.162301 5.2475876 + 7800 9.7278145 9.801009 5.0685504 + 7850 9.8639905 10.323104 5.2458864 + 7900 9.7246799 9.1377357 5.1841319 + 7950 10.381792 9.6977533 5.0977386 + 8000 9.7265224 9.2999829 4.7925571 + 8050 9.5203288 9.3144956 4.7539211 + 8100 9.6900973 9.6614063 5.304712 + 8150 9.713677 9.9154149 4.8178575 + 8200 9.4733597 9.8948632 5.036112 + 8250 9.7783036 9.9554334 5.3355682 + 8300 9.4034783 9.9156801 5.5539279 + 8350 9.2984025 9.2013949 5.0753991 + 8400 9.9299078 9.6166801 5.115776 + 8450 9.526737 9.3312125 4.7800587 + 8500 9.581956 10.065906 4.9756092 + 8550 9.2767953 9.326006 5.3024978 + 8600 9.799968 8.4660845 5.0199109 + 8650 9.8985354 10.127852 4.9098064 + 8700 8.7952691 10.521133 5.6840528 + 8750 9.8299997 9.5588553 5.3085734 + 8800 9.0811776 9.5704532 5.1684993 + 8850 9.8303571 9.7618932 5.1251259 + 8900 9.9238794 9.9654863 5.2999683 + 8950 10.851304 9.9682289 5.4133763 + 9000 9.5523794 9.1890766 5.1469144 + 9050 9.7461948 8.9611236 4.9490826 + 9100 10.138917 9.6757567 5.0473544 + 9150 9.4869835 9.4786575 5.0142464 + 9200 10.263518 10.079135 5.1493398 + 9250 9.8691684 9.0908275 5.3221203 + 9300 9.8586707 9.4177643 5.1525265 + 9350 9.3375816 9.9167208 5.4846207 + 9400 9.5603903 9.4813199 4.6237495 + 9450 10.30892 9.5217736 5.6163214 + 9500 9.327949 9.9831649 4.8923915 + 9550 9.8421656 9.3202702 5.3352046 + 9600 8.8543704 9.4556702 4.6430041 + 9650 10.103399 9.2161072 4.8658062 + 9700 9.507811 9.9647378 5.227369 + 9750 9.4988096 8.9942893 5.2491418 + 9800 9.8007958 9.234452 5.1740203 + 9850 9.6029685 10.076042 5.023107 + 9900 9.4035691 10.13782 5.2775777 + 9950 9.6517135 10.355994 5.3035779 + 10000 9.9157616 9.7741952 5.5269431 +Loop time of 4.303 on 1 procs for 10000 steps with 500 atoms + +Performance: 1003950.961 tau/day, 2323.961 timesteps/s +99.7% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.69667 | 0.69667 | 0.69667 | 0.0 | 16.19 +Neigh | 2.699 | 2.699 | 2.699 | 0.0 | 62.72 +Comm | 0.30701 | 0.30701 | 0.30701 | 0.0 | 7.13 +Output | 0.003968 | 0.003968 | 0.003968 | 0.0 | 0.09 +Modify | 0.49374 | 0.49374 | 0.49374 | 0.0 | 11.47 +Other | | 0.1026 | | | 2.38 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 908 ave 908 max 908 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 3489 ave 3489 max 3489 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 3489 +Ave neighs/atom = 6.978 +Neighbor list builds = 4567 +Dangerous builds = 0 +Total wall time: 0:00:04 diff --git a/examples/USER/uef/nvt_uniaxial/log.30Jul16.npt_uniaxial.g++.4 b/examples/USER/uef/nvt_uniaxial/log.30Jul16.npt_uniaxial.g++.4 new file mode 100644 index 0000000000000000000000000000000000000000..f977bf4e7d3055d781ba43be254cde46f7d5273d --- /dev/null +++ b/examples/USER/uef/nvt_uniaxial/log.30Jul16.npt_uniaxial.g++.4 @@ -0,0 +1,273 @@ +LAMMPS (30 Jul 2016) +# uniaxial NVT deformation of WCA fluid + +units lj +atom_style atomic + + +pair_style lj/cut 1.122562 +read_data data.wca + orthogonal box = (0 0 0) to (8.39798 8.39798 8.39798) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 500 atoms + reading velocities ... + 500 velocities +pair_coeff 1 1 1.0 1.0 +pair_modify shift yes + +neighbor 0.5 bin +neigh_modify delay 0 + +change_box all triclinic + triclinic box = (0 0 0) to (8.39798 8.39798 8.39798) with tilt (0 0 0) + +fix 1 all nvt/uef temp 0.722 0.722 0.5 erate -0.5 -0.5 + +fix 2 all momentum 100 linear 1 1 1 + +#dump 1 all atom 25 dump.lammpstrj + +#dump 2 all cfg/uef 25 dump.*.cfg mass type xs ys zs + +thermo_style custom step c_1_press[1] c_1_press[2] c_1_press[3] + +thermo 50 +run 10000 +Neighbor list info ... + 1 neighbor list requests + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 1.62256 + ghost atom cutoff = 1.62256 + binsize = 0.811281 -> bins = 11 11 11 +Memory usage per processor = 2.38201 Mbytes +Step 1_press[ 1_press[ 1_press[ + 0 6.3937851 7.0436438 6.4461087 + 50 10.369902 10.999889 6.5437384 + 100 12.411384 13.145871 7.8892802 + 150 12.88182 12.114068 7.5155182 + 200 10.375571 10.979773 6.5624056 + 250 10.158901 10.251273 5.4525068 + 300 10.011314 9.8371382 5.4031393 + 350 9.4890008 9.7992108 5.054963 + 400 9.1715116 9.2647886 4.9600208 + 450 9.8495961 9.3353483 4.986786 + 500 9.5903809 8.576173 4.8252116 + 550 8.8057509 9.7152078 4.9089022 + 600 8.9743682 10.031277 4.8924072 + 650 10.233852 9.3059527 5.1977058 + 700 9.2361906 9.6439971 5.0923762 + 750 10.449751 9.5911465 5.2548714 + 800 9.8366858 9.9873885 4.9456956 + 850 10.266351 9.9620134 5.0602713 + 900 9.6325811 9.3910947 5.1466627 + 950 9.1911905 9.1518997 4.8275335 + 1000 9.2871725 9.8508561 5.2674079 + 1050 9.7052018 10.291782 5.1603606 + 1100 9.942582 10.361849 5.5520591 + 1150 10.37757 10.265893 5.5997259 + 1200 9.6367107 10.354442 5.4138733 + 1250 9.2075329 9.1705 4.9806587 + 1300 9.7125232 8.724748 4.852827 + 1350 10.146185 9.8320894 4.8958299 + 1400 9.1958247 9.7053023 5.2334931 + 1450 9.4656613 8.9011194 4.7069541 + 1500 9.0964228 9.8379154 4.8889701 + 1550 10.074953 9.8121208 5.1614034 + 1600 10.14322 9.7113028 5.0901612 + 1650 9.9377801 9.8831912 5.2226793 + 1700 9.4144883 8.5248477 4.9447402 + 1750 9.0729219 9.612432 5.1999941 + 1800 10.067363 9.8211216 5.1464764 + 1850 9.3044429 8.9752352 5.0515339 + 1900 9.4123739 9.1810527 5.3356061 + 1950 9.3009721 10.013851 4.9527398 + 2000 9.7741829 10.11286 5.3818321 + 2050 9.6991106 9.7815812 5.1979016 + 2100 9.2977435 9.4310005 5.0893893 + 2150 10.325992 10.388415 4.9253076 + 2200 10.193251 10.389764 5.4164579 + 2250 9.9386988 9.63934 5.1685251 + 2300 9.3128664 10.496199 5.423297 + 2350 8.692096 9.761347 5.1356802 + 2400 9.4532892 9.2946894 5.3127538 + 2450 9.026436 8.8042728 4.9305279 + 2500 8.9458518 9.6338731 5.1530972 + 2550 8.9457961 9.7730997 5.1588 + 2600 9.4313048 9.0489105 4.9937356 + 2650 9.1625701 10.03039 4.9384831 + 2700 10.135274 9.9106295 5.1582637 + 2750 9.7419819 9.7329998 5.4813308 + 2800 9.6793568 10.137218 4.9126985 + 2850 9.8286116 9.8283148 5.2372177 + 2900 9.2766894 9.5302835 5.1206658 + 2950 9.6537203 9.8713609 5.2640351 + 3000 9.704446 10.360629 5.2470236 + 3050 9.289114 10.210593 4.9955164 + 3100 9.5854695 9.0377602 5.0387963 + 3150 9.4489179 9.0145734 4.9089788 + 3200 8.9221328 8.8805863 4.7910012 + 3250 8.9268792 8.6855592 4.7798689 + 3300 9.5280088 9.6859376 5.1021255 + 3350 9.7469167 9.7039449 5.3654161 + 3400 10.163823 10.247303 5.3206912 + 3450 10.328168 9.2596091 5.3903402 + 3500 10.280033 10.087996 5.3980267 + 3550 9.5278822 10.057563 4.9949376 + 3600 9.3705739 9.9639827 5.1315405 + 3650 10.003355 9.0323131 5.288539 + 3700 9.5814093 9.742063 4.9937322 + 3750 9.1121545 9.9600773 5.2621763 + 3800 8.4753486 9.2930472 4.8939508 + 3850 9.309286 9.0227214 4.9323125 + 3900 9.0283302 10.048011 5.0801404 + 3950 10.193343 10.279252 5.4390015 + 4000 9.5170246 9.8575174 5.3284718 + 4050 9.0306235 9.4210217 4.7042159 + 4100 9.7801264 10.267131 4.8946632 + 4150 10.161985 10.327002 5.3719225 + 4200 10.242291 9.5148633 5.2938589 + 4250 9.67955 10.025696 5.517063 + 4300 9.0818798 9.655456 5.0976568 + 4350 9.3181275 8.8534154 4.9252792 + 4400 9.4111133 8.9481402 4.8338338 + 4450 10.219905 10.0317 5.3278766 + 4500 9.9718967 9.9808168 5.2294123 + 4550 9.7194794 9.7613441 5.3369724 + 4600 9.4826038 9.5426517 5.1951956 + 4650 9.5794203 8.4729044 4.9375856 + 4700 9.6409231 10.059765 4.9659309 + 4750 9.0853564 9.6062246 5.1560466 + 4800 9.5805015 10.26319 5.1395845 + 4850 8.8662041 9.4757304 5.1729905 + 4900 9.6230855 10.239009 5.1382048 + 4950 10.401327 9.5494971 5.2688637 + 5000 10.433047 9.9017863 5.4626886 + 5050 10.318188 9.2998964 5.4707543 + 5100 9.6958274 9.206341 5.0269859 + 5150 9.5477552 10.099142 5.3760873 + 5200 9.4904189 9.4403777 5.1638292 + 5250 9.8421539 8.7828543 4.8612713 + 5300 9.7354196 9.357113 4.9059656 + 5350 9.9183987 9.4337973 5.2986167 + 5400 10.045743 9.8399757 5.0930923 + 5450 9.6414177 10.169944 5.3868716 + 5500 10.035214 9.5316451 4.912222 + 5550 9.16334 9.3853532 5.2319683 + 5600 9.5075535 9.2548959 5.4425531 + 5650 9.3854437 9.0700172 4.9845383 + 5700 9.1868937 9.3061525 4.9155762 + 5750 9.4785528 9.8271693 4.9974045 + 5800 9.7809419 10.070618 5.3699816 + 5850 10.791132 10.572676 5.3816834 + 5900 10.091884 10.036391 5.7604455 + 5950 9.4492785 8.9938163 4.9812227 + 6000 9.2296463 10.334517 5.6374553 + 6050 9.9339781 9.1097471 4.6847041 + 6100 10.369857 9.261491 5.3354256 + 6150 9.9444024 9.5330721 5.2413981 + 6200 9.1507255 9.2108005 4.7010871 + 6250 9.6093995 9.2275894 4.8659261 + 6300 9.0300283 9.149341 4.9305141 + 6350 9.6718904 9.5721387 4.9560051 + 6400 9.615362 10.030978 4.8786582 + 6450 10.343763 10.184481 5.2027613 + 6500 9.3452563 9.7249417 5.2318842 + 6550 9.9489414 10.373436 4.9258407 + 6600 10.083741 10.87974 5.3665699 + 6650 9.431476 9.7944015 5.4214407 + 6700 9.3430129 10.032417 4.8538936 + 6750 10.253341 9.5667637 5.3838115 + 6800 8.9695591 9.888476 4.7973343 + 6850 9.6952765 9.3339082 4.8432603 + 6900 9.1038139 9.6295207 4.8572214 + 6950 9.5374663 9.0498856 5.2316356 + 7000 8.6844415 9.1416318 4.9513449 + 7050 9.6271147 8.8341922 5.135948 + 7100 9.3889214 9.6771129 5.1106028 + 7150 9.4697432 9.9959141 4.8762717 + 7200 9.9545962 9.5556848 5.2760968 + 7250 10.153728 10.396722 5.4066282 + 7300 9.5633599 9.8262997 5.5238788 + 7350 10.476059 9.8526241 4.9928222 + 7400 9.5848947 9.389115 5.1177333 + 7450 9.3917853 9.8395056 5.5201002 + 7500 9.2406374 9.4598141 4.9336365 + 7550 9.1325284 9.0585 5.007436 + 7600 9.5045307 9.5164648 4.8310378 + 7650 9.5165952 9.5154581 5.3199138 + 7700 9.1167042 9.3283907 4.9548988 + 7750 9.5408306 10.191558 5.1889476 + 7800 9.2362359 9.5066276 5.4139251 + 7850 9.9533215 9.3418618 5.0073354 + 7900 9.063471 9.2389687 5.1529568 + 7950 9.6887619 9.3363144 5.0264365 + 8000 10.244559 10.352116 5.3898068 + 8050 10.522656 9.7844249 5.648648 + 8100 10.456047 10.108097 5.234203 + 8150 9.0497599 10.3333 5.5526068 + 8200 9.1341912 9.7046196 4.7491692 + 8250 9.3297032 9.2513325 4.9471519 + 8300 9.9385635 9.8432553 4.9102209 + 8350 9.506086 9.3628428 5.4489526 + 8400 9.7575572 9.6628477 4.7835143 + 8450 9.4234184 9.6901535 5.2506704 + 8500 9.1019018 9.4713605 4.9996292 + 8550 8.9668254 9.2297952 4.9015639 + 8600 10.000082 9.852912 5.1235791 + 8650 9.6677771 9.8825377 5.0888713 + 8700 9.5220305 9.6140025 5.2621374 + 8750 9.769165 9.1639605 4.942283 + 8800 10.214712 9.0544214 5.0977658 + 8850 10.050644 8.9450446 4.876467 + 8900 9.7066878 9.8028705 5.1098917 + 8950 9.8322209 9.5247394 5.1258681 + 9000 10.116755 9.9220422 5.2801505 + 9050 9.671068 9.448618 5.1789641 + 9100 8.6872235 9.8346401 4.8940421 + 9150 9.8181714 9.652061 4.9136383 + 9200 9.5400873 9.9027439 5.3147415 + 9250 9.2344784 9.9272383 5.397571 + 9300 9.0207063 9.2498921 5.0643988 + 9350 10.648665 9.0509298 5.0354353 + 9400 9.7266263 9.5319347 5.4323366 + 9450 9.5044169 9.7968623 5.2079039 + 9500 9.0459316 9.6916313 5.1584987 + 9550 9.1265901 10.045493 4.9476229 + 9600 9.896449 9.509792 5.5305989 + 9650 9.2957435 9.4288068 5.1885785 + 9700 9.6000499 8.7187335 5.0900953 + 9750 9.5997652 9.4810899 4.8707106 + 9800 9.2198937 9.7067006 5.4461186 + 9850 9.8794169 10.051937 5.0361319 + 9900 9.9783069 9.9785092 5.2066807 + 9950 9.0880268 9.5659803 5.3678011 + 10000 9.6972182 9.9076171 5.1538951 +Loop time of 2.23728 on 4 procs for 10000 steps with 500 atoms + +Performance: 1930919.704 tau/day, 4469.722 timesteps/s +99.8% CPU use with 4 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.26111 | 0.26444 | 0.26854 | 0.5 | 11.82 +Neigh | 1.0268 | 1.037 | 1.0467 | 0.7 | 46.35 +Comm | 0.5321 | 0.55022 | 0.56515 | 1.6 | 24.59 +Output | 0.003746 | 0.0045477 | 0.006809 | 1.9 | 0.20 +Modify | 0.26509 | 0.26827 | 0.27182 | 0.5 | 11.99 +Other | | 0.1128 | | | 5.04 + +Nlocal: 125 ave 128 max 123 min +Histogram: 2 0 0 0 0 0 1 0 0 1 +Nghost: 468.25 ave 470 max 467 min +Histogram: 2 0 0 0 0 0 1 0 0 1 +Neighs: 869.75 ave 895 max 843 min +Histogram: 1 0 0 0 1 0 1 0 0 1 + +Total # of neighbors = 3479 +Ave neighs/atom = 6.958 +Neighbor list builds = 4555 +Dangerous builds = 0 +Total wall time: 0:00:02 diff --git a/src/Makefile b/src/Makefile index 243ac869e90a4de35c4cb701ad05fc792069649a..e0f0db77fe3d5eea0ed95b04541047344919ee45 100644 --- a/src/Makefile +++ b/src/Makefile @@ -63,7 +63,7 @@ PACKUSER = user-atc user-awpmd user-cgdna user-cgsdk user-colvars \ user-mgpt user-misc user-molfile \ user-netcdf user-omp user-phonon user-qmmm user-qtb \ user-quip user-reaxc user-smd user-smtbq user-sph user-tally \ - user-vtk + user-uef user-vtk PACKLIB = compress gpu kim kokkos latte meam mpiio mscg poems \ python reax voronoi \ diff --git a/src/USER-UEF/compute_pressure_uef.cpp b/src/USER-UEF/compute_pressure_uef.cpp new file mode 100644 index 0000000000000000000000000000000000000000..e9bbdf0cf4c8f280a1148a91bd4d15f72fff41bd --- /dev/null +++ b/src/USER-UEF/compute_pressure_uef.cpp @@ -0,0 +1,198 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. + + Contributing author: David Nicholson (MIT) +------------------------------------------------------------------------- */ + +#include "mpi.h" +#include "string.h" +#include "stdlib.h" +#include "compute_pressure_uef.h" +#include "fix_nh_uef.h" +#include "update.h" +#include "domain.h" +#include "modify.h" +#include "fix.h" +#include "force.h" +#include "pair.h" +#include "bond.h" +#include "angle.h" +#include "dihedral.h" +#include "improper.h" +#include "kspace.h" +#include "error.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- + * Default values for the ext flags + * ----------------------------------------------------------------------*/ +ComputePressureUef::ComputePressureUef(LAMMPS *lmp, int narg, char **arg) : + ComputePressure(lmp, narg, arg) + { + ext_flags[0] = true; + ext_flags[1] = true; + ext_flags[2] = true; + in_fix=false; + } + +/* ---------------------------------------------------------------------- + * Check for the uef fix + * ----------------------------------------------------------------------*/ +void ComputePressureUef::init() +{ + ComputePressure::init(); + // check to make sure the other uef fix is on + // borrowed from Pieter's nvt/sllod code + int i=0; + for (i=0; i<modify->nfix; i++) + { + if (strcmp(modify->fix[i]->style,"nvt/uef")==0) + break; + if (strcmp(modify->fix[i]->style,"npt/uef")==0) + break; + } + if (i==modify->nfix) + error->all(FLERR,"Can't use compute pressure/uef without defining a fix nvt/npt/uef"); + ifix_uef=i; + ((FixNHUef*) modify->fix[ifix_uef])->get_ext_flags(ext_flags); + + if (strcmp(temperature->style,"temp/uef") != 0) + error->warning(FLERR,"The temperature used in compute pressure/ued is not of style temp/uef"); +} + +/* ---------------------------------------------------------------------- + * Compute pressure in the directions i corresponding to ext_flag[i]=true + * ----------------------------------------------------------------------*/ +double ComputePressureUef::compute_scalar() +{ + + temperature->compute_scalar(); +// if all pressures are external the scalar is found as normal + if (ext_flags[0] && ext_flags[1] && ext_flags[2]) + return ComputePressure::compute_scalar(); + +// otherwise compute the full tensor and average desired components + compute_vector(); + addstep(update->ntimestep+1); + + int k =0; + scalar = 0; + if (ext_flags[0]) + { + scalar += vector[0]; + k++; + } + if (ext_flags[1]) + { + scalar += vector[1]; + k++; + } + if (ext_flags[2]) + { + scalar += vector[2]; + k++; + } + + scalar /= k; + return scalar; +} + +/* ---------------------------------------------------------------------- + Compute the pressure tensor in the rotated coordinate system +------------------------------------------------------------------------- */ +void ComputePressureUef::compute_vector() +{ + invoked_vector = update->ntimestep; + if (update->vflag_global != invoked_vector) + error->all(FLERR,"Virial was not tallied on needed timestep"); + + if (force->kspace && kspace_virial && force->kspace->scalar_pressure_flag) + error->all(FLERR,"Must use 'kspace_modify pressure/scalar no' for " + "tensor components with kspace_style msm"); + + // invoke temperature if it hasn't been already + + double *ke_tensor; + if (keflag) { + if (temperature->invoked_vector != update->ntimestep) + temperature->compute_vector(); + ke_tensor = temperature->vector; + } + + if (dimension == 3) { + inv_volume = 1.0 / (domain->xprd * domain->yprd * domain->zprd); + virial_compute(6,3); + if (in_fix) + virial_rot(virial,rot); + else + { + double r[3][3]; + ( (FixNHUef*) modify->fix[ifix_uef])->get_rot(r); + virial_rot(virial,r); + } + if (keflag) { + for (int i = 0; i < 6; i++) + vector[i] = (ke_tensor[i] + virial[i]) * inv_volume * nktv2p; + } else + for (int i = 0; i < 6; i++) + vector[i] = virial[i] * inv_volume * nktv2p; + } else { + inv_volume = 1.0 / (domain->xprd * domain->yprd); + virial_compute(4,2); + if (keflag) { + vector[0] = (ke_tensor[0] + virial[0]) * inv_volume * nktv2p; + vector[1] = (ke_tensor[1] + virial[1]) * inv_volume * nktv2p; + vector[3] = (ke_tensor[3] + virial[3]) * inv_volume * nktv2p; + vector[2] = vector[4] = vector[5] = 0.0; + } else { + vector[0] = virial[0] * inv_volume * nktv2p; + vector[1] = virial[1] * inv_volume * nktv2p; + vector[3] = virial[3] * inv_volume * nktv2p; + vector[2] = vector[4] = vector[5] = 0.0; + } + } +} + +/* ---------------------------------------------------------------------- + * get the current rotation matrix and store it +------------------------------------------------------------------------- */ +void ComputePressureUef::update_rot() +{ + ( (FixNHUef*) modify->fix[ifix_uef])->get_rot(rot); +} + +/* ---------------------------------------------------------------------- + Transform the pressure tensor to the rotated coordinate system + [P]rot = Q.[P].Q^t +------------------------------------------------------------------------- */ +void ComputePressureUef::virial_rot(double *x, const double r[3][3]) +{ + + double t[3][3]; + // [00 10 20 ] [ 0 3 4 ] [00 01 02 ] + // [01 11 21 ] [ 3 1 5 ] [10 11 12 ] + // [02 12 22 ] [ 4 5 2 ] [20 21 22 ] + for (int k = 0; k<3; ++k) + { + t[0][k] = x[0]*r[0][k] + x[3]*r[1][k] + x[4]*r[2][k]; + t[1][k] = x[3]*r[0][k] + x[1]*r[1][k] + x[5]*r[2][k]; + t[2][k] = x[4]*r[0][k] + x[5]*r[1][k] + x[2]*r[2][k]; + } + x[0] = r[0][0]*t[0][0] + r[1][0]*t[1][0] + r[2][0]*t[2][0]; + x[3] = r[0][0]*t[0][1] + r[1][0]*t[1][1] + r[2][0]*t[2][1]; + x[4] = r[0][0]*t[0][2] + r[1][0]*t[1][2] + r[2][0]*t[2][2]; + x[1] = r[0][1]*t[0][1] + r[1][1]*t[1][1] + r[2][1]*t[2][1]; + x[5] = r[0][1]*t[0][2] + r[1][1]*t[1][2] + r[2][1]*t[2][2]; + x[2] = r[0][2]*t[0][2] + r[1][2]*t[1][2] + r[2][2]*t[2][2]; +} + diff --git a/src/USER-UEF/compute_pressure_uef.h b/src/USER-UEF/compute_pressure_uef.h new file mode 100644 index 0000000000000000000000000000000000000000..2f591b64d82ffc63a3439464aebb29cedb1d6f46 --- /dev/null +++ b/src/USER-UEF/compute_pressure_uef.h @@ -0,0 +1,66 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. + + Contributing author: David Nicholson (MIT) +------------------------------------------------------------------------- */ + +#ifdef COMPUTE_CLASS + +ComputeStyle(pressure/uef,ComputePressureUef) + +#else + +#ifndef LMP_COMPUTE_PRESSURE_UEF_H +#define LMP_COMPUTE_PRESSURE_UEF_H + +#include "compute_pressure.h" + +namespace LAMMPS_NS { + +class ComputePressureUef : public ComputePressure { + public: + ComputePressureUef(class LAMMPS *, int, char **); + virtual ~ComputePressureUef(){} + virtual void init(); + virtual void compute_vector(); + virtual double compute_scalar(); + void update_rot(); + bool in_fix; //true if this compute is used in fix/nvt/npt + + + protected: + bool ext_flags[3]; // true if used in average output pressure + void virial_rot(double*,const double[3][3]); + int ifix_uef; + double rot[3][3]; +}; + + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +This class inherits most of the warnings from ComputePressure. The +only additions are: + +E: Can't use compute pressure/uef without defining a fix nvt/npt/uef + +Self-explanatory. + +W: The temperature used in compute pressure/uef is not of style temp/uef + +Self-explanatory. + +*/ diff --git a/src/USER-UEF/compute_temp_uef.cpp b/src/USER-UEF/compute_temp_uef.cpp new file mode 100644 index 0000000000000000000000000000000000000000..8c8c9be29307615d4a44d37522b41c286c81b693 --- /dev/null +++ b/src/USER-UEF/compute_temp_uef.cpp @@ -0,0 +1,110 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. + + Contributing author: David Nicholson (MIT) +------------------------------------------------------------------------- */ + +#include "string.h" +#include "stdlib.h" +#include "compute_temp_uef.h" +#include "fix_nh_uef.h" +#include "update.h" +#include "modify.h" +#include "fix.h" +#include "error.h" + +using namespace LAMMPS_NS; + +/* ---------------------------------------------------------------------- + * Base constructor initialized to use rotation matrix + * ----------------------------------------------------------------------*/ +ComputeTempUef::ComputeTempUef(LAMMPS *lmp, int narg, char **arg) : + ComputeTemp(lmp, narg, arg) +{ + rot_flag=true; +} + +/* ---------------------------------------------------------------------- + * Check for the uef fix + * ----------------------------------------------------------------------*/ +void ComputeTempUef::init() +{ + ComputeTemp::init(); + // check to make sure the other uef fix is on + // borrowed from Pieter's nvt/sllod code + int i=0; + for (i=0; i<modify->nfix; i++) + { + if (strcmp(modify->fix[i]->style,"nvt/uef")==0) + break; + if (strcmp(modify->fix[i]->style,"npt/uef")==0) + break; + } + if (i==modify->nfix) + error->all(FLERR,"Can't use compute temp/uef without defining a fix nvt/npt/uef"); + ifix_uef=i; +} + + +/* ---------------------------------------------------------------------- + Compute the ke tensor in the proper coordinate system +------------------------------------------------------------------------- */ +void ComputeTempUef::compute_vector() +{ + ComputeTemp::compute_vector(); + if (rot_flag) + { + double rot[3][3]; + ( (FixNHUef*) modify->fix[ifix_uef])->get_rot(rot); + virial_rot(vector,rot); + } + +} + +/* ---------------------------------------------------------------------- + * turn the rotation matrix on or off to properly account for the + * coordinate system of the velocities +------------------------------------------------------------------------- */ +void ComputeTempUef::yes_rot() +{ + rot_flag =true; +} +void ComputeTempUef::no_rot() +{ + rot_flag =false; +} + +/* ---------------------------------------------------------------------- + Transform the pressure tensor to the rotated coordinate system + [P]rot = Q.[P].Q^t +------------------------------------------------------------------------- */ +void ComputeTempUef::virial_rot(double *x, const double r[3][3]) +{ + + double t[3][3]; + // [00 10 20 ] [ 0 3 4 ] [00 01 02 ] + // [01 11 21 ] [ 3 1 5 ] [10 11 12 ] + // [02 12 22 ] [ 4 5 2 ] [20 21 22 ] + for (int k = 0; k<3; ++k) + { + t[0][k] = x[0]*r[0][k] + x[3]*r[1][k] + x[4]*r[2][k]; + t[1][k] = x[3]*r[0][k] + x[1]*r[1][k] + x[5]*r[2][k]; + t[2][k] = x[4]*r[0][k] + x[5]*r[1][k] + x[2]*r[2][k]; + } + x[0] = r[0][0]*t[0][0] + r[1][0]*t[1][0] + r[2][0]*t[2][0]; + x[3] = r[0][0]*t[0][1] + r[1][0]*t[1][1] + r[2][0]*t[2][1]; + x[4] = r[0][0]*t[0][2] + r[1][0]*t[1][2] + r[2][0]*t[2][2]; + x[1] = r[0][1]*t[0][1] + r[1][1]*t[1][1] + r[2][1]*t[2][1]; + x[5] = r[0][1]*t[0][2] + r[1][1]*t[1][2] + r[2][1]*t[2][2]; + x[2] = r[0][2]*t[0][2] + r[1][2]*t[1][2] + r[2][2]*t[2][2]; +} + diff --git a/src/USER-UEF/compute_temp_uef.h b/src/USER-UEF/compute_temp_uef.h new file mode 100644 index 0000000000000000000000000000000000000000..2e9dc901c0bcb2f59b2a431a1d22afc99e3eff87 --- /dev/null +++ b/src/USER-UEF/compute_temp_uef.h @@ -0,0 +1,60 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. + + Contributing author: David Nicholson (MIT) +------------------------------------------------------------------------- */ + +#ifdef COMPUTE_CLASS + +ComputeStyle(temp/uef,ComputeTempUef) + +#else + +#ifndef LMP_COMPUTE_TEMP_UEF_H +#define LMP_COMPUTE_TEMP_UEF_H + +#include "compute_temp.h" + +namespace LAMMPS_NS { + +class ComputeTempUef : public ComputeTemp { + public: + ComputeTempUef(class LAMMPS *, int, char **); + virtual ~ComputeTempUef(){} + virtual void init(); + virtual void compute_vector(); + void yes_rot(); + void no_rot(); + + + protected: + bool rot_flag; + void virial_rot(double*,const double[3][3]); + int ifix_uef; +}; + + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +This class inherits most of the warnings from ComputePressure. The +only addition is: + +E: Can't use compute temp/uef without defining a fix nvt/npt/uef + +Self-explanatory. + +*/ diff --git a/src/USER-UEF/dump_cfg_uef.cpp b/src/USER-UEF/dump_cfg_uef.cpp new file mode 100644 index 0000000000000000000000000000000000000000..2ee216934c5e03df7b86e831aaae4dc62032fe2d --- /dev/null +++ b/src/USER-UEF/dump_cfg_uef.cpp @@ -0,0 +1,113 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. + + Contributing Author: David Nicholson (MIT) +------------------------------------------------------------------------- */ + + +#include <math.h> +#include <stdlib.h> +#include <string.h> +#include "dump_cfg.h" +#include "atom.h" +#include "domain.h" +#include "modify.h" +#include "compute.h" +#include "fix.h" +#include "error.h" +#include "dump_cfg_uef.h" +#include "fix_nh_uef.h" + +using namespace LAMMPS_NS; + +enum{INT,DOUBLE,STRING,BIGINT}; // same as in DumpCustom + +#define UNWRAPEXPAND 10.0 +#define ONEFIELD 32 +#define DELTA 1048576 + +/* ---------------------------------------------------------------------- + * base method is mostly fine, just need to find the FixNHUef + * ----------------------------------------------------------------------*/ +void DumpCFGUef::init_style() +{ + DumpCFG::init_style(); + + // check to make sure the other uef fix is on + // borrowed from Pieter's nvt/sllod code + int i=0; + for (i=0; i<modify->nfix; i++) + { + if (strcmp(modify->fix[i]->style,"nvt/uef")==0) + break; + if (strcmp(modify->fix[i]->style,"npt/uef")==0) + break; + } + if (i==modify->nfix) + error->all(FLERR,"Can't use dump cfg/uef without defining a fix nvt/npt/uef"); + ifix_uef=i; +} + +/* ---------------------------------------------------------------------- + * this is really the only difference between the base class and this one. + * since the output is in scaled coordinates, changing the simulation box + * edges to the flow frame will put coordinates in the flow frame too. + * ----------------------------------------------------------------------*/ + +void DumpCFGUef::write_header(bigint n) +{ + // set scale factor used by AtomEye for CFG viz + // default = 1.0 + // for peridynamics, set to pre-computed PD scale factor + // so PD particles mimic C atoms + // for unwrapped coords, set to UNWRAPEXPAND (10.0) + // so molecules are not split across periodic box boundaries + + double box[3][3],rot[3][3]; + ((FixNHUef*) modify->fix[ifix_uef])->get_box(box); + ((FixNHUef*) modify->fix[ifix_uef])->get_rot(rot); + // rot goes from "lab frame" to "upper triangular frame" + // it's transpose takes the simulation box to the flow frame + for (int i=0;i<3;i++) + for(int j=i+1;j<3;j++) + { + double t=rot[i][j]; + rot[i][j]=rot[j][i]; + rot[j][i]=t; + } + mul_m2(rot,box); + + + double scale = 1.0; + if (atom->peri_flag) scale = atom->pdscale; + else if (unwrapflag == 1) scale = UNWRAPEXPAND; + + char str[64]; + sprintf(str,"Number of particles = %s\n",BIGINT_FORMAT); + fprintf(fp,str,n); + fprintf(fp,"A = %g Angstrom (basic length-scale)\n",scale); + // in box[][] columns are cell edges + // in H0, rows are cell edges + fprintf(fp,"H0(1,1) = %g A\n",box[0][0]); + fprintf(fp,"H0(1,2) = %g A\n",box[1][0]); + fprintf(fp,"H0(1,3) = %g A\n",box[2][0]); + fprintf(fp,"H0(2,1) = %g A\n",box[0][1]); + fprintf(fp,"H0(2,2) = %g A\n",box[1][1]); + fprintf(fp,"H0(2,3) = %g A\n",box[2][1]); + fprintf(fp,"H0(3,1) = %g A\n",box[0][2]); + fprintf(fp,"H0(3,2) = %g A\n",box[1][2]); + fprintf(fp,"H0(3,3) = %g A\n",box[2][2]); + fprintf(fp,".NO_VELOCITY.\n"); + fprintf(fp,"entry_count = %d\n",nfield-2); + for (int i = 0; i < nfield-5; i++) + fprintf(fp,"auxiliary[%d] = %s\n",i,auxname[i]); +} diff --git a/src/USER-UEF/dump_cfg_uef.h b/src/USER-UEF/dump_cfg_uef.h new file mode 100644 index 0000000000000000000000000000000000000000..059fc63008a0b250038f55a5e9dfd214ad8b30a9 --- /dev/null +++ b/src/USER-UEF/dump_cfg_uef.h @@ -0,0 +1,51 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. + + Contributing Author: David Nicholson (MIT) +------------------------------------------------------------------------- */ + +#ifdef DUMP_CLASS + +DumpStyle(cfg/uef,DumpCFGUef) + +#else + +#ifndef LMP_DUMP_CFG_UEF_H +#define LMP_DUMP_CFG_UEF_H + +#include "dump_cfg.h" + +namespace LAMMPS_NS { + +class DumpCFGUef : public DumpCFG { + public: + DumpCFGUef(LAMMPS *lmp, int narg, char **arg) : + DumpCFG(lmp, narg, arg){} + void init_style(); + void write_header(bigint); + + protected: + int ifix_uef; +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Can't use dump cfg/uef without defining a fix nvt/npt/uef + +Self-explanatory. + +*/ diff --git a/src/USER-UEF/fix_nh_uef.cpp b/src/USER-UEF/fix_nh_uef.cpp new file mode 100644 index 0000000000000000000000000000000000000000..74d4e78746225b46b5ca4d2da5ef7111b508d0f3 --- /dev/null +++ b/src/USER-UEF/fix_nh_uef.cpp @@ -0,0 +1,846 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + www.cs.sandia.gov/~sjplimp/lammps.html + Steve Plimpton, sjplimp@sandia.gov, Sandia National Laboratories + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. + + Contributing author: David Nicholson (MIT) +------------------------------------------------------------------------- */ + +#include "string.h" +#include "stdlib.h" +#include "math.h" +#include "fix_nh_uef.h" +#include "atom.h" +#include "force.h" +#include "group.h" +#include "comm.h" +#include "irregular.h" +#include "modify.h" +#include "compute.h" +#include "kspace.h" +#include "update.h" +#include "domain.h" +#include "error.h" +#include "output.h" +#include "timer.h" +#include "neighbor.h" +#include "compute_pressure_uef.h" +#include "compute_temp_uef.h" + +using namespace LAMMPS_NS; +using namespace FixConst; + +enum{ISO,ANISO,TRICLINIC}; +/* ---------------------------------------------------------------------- + Put all of the uef-only keywords at the back of arg and make narg smaller + so FixNH::FixNH() only sees the keywords it knows. Save the numer of + remaining keywords in rem. + ---------------------------------------------------------------------- */ +char ** FixNHUef::arg_kludge(int &narg, char **arg, int &rem) +{ + int iarg = 3; + bool flags[3]= {false,false,false}; + rem=0; + char *tmp[3]; + while (iarg < narg) + { + if (strcmp(arg[iarg],"erate" ) == 0 && !flags[0]) + { + tmp[0] = arg[iarg]; + tmp[1] = arg[iarg+1]; + tmp[2] = arg[iarg+2]; + for (int k=iarg+3; k<narg; k++) + arg[k-3] = arg[k]; + arg[narg-1] = tmp[2]; + arg[narg-2] = tmp[1]; + arg[narg-3] = tmp[0]; + rem += 3; + flags[0] = true; + } + else if (strcmp(arg[iarg],"strain" ) == 0 && !flags[1]) + { + tmp[0] = arg[iarg]; + tmp[1] = arg[iarg+1]; + tmp[2] = arg[iarg+2]; + for (int k=iarg+3; k<narg; k++) + arg[k-3] = arg[k]; + arg[narg-1] = tmp[2]; + arg[narg-2] = tmp[1]; + arg[narg-3] = tmp[0]; + rem += 3; + flags[1] = true; + } + else if(strcmp(arg[iarg],"ext") == 0 && !flags[2]) + { + tmp[0] = arg[iarg]; + tmp[1] = arg[iarg+1]; + for (int k=iarg+2; k<narg; k++) + arg[k-2] = arg[k]; + arg[narg-1] = tmp[1]; + arg[narg-2] = tmp[0]; + rem += 2; + flags[2] = true; + } + else + iarg++; + } + narg -= rem; + return arg; +} + +/* ---------------------------------------------------------------------- + * Parse the remaing keywords, do some error checking, and initalize + * temp/pressure fixes + ---------------------------------------------------------------------- */ +FixNHUef::FixNHUef(LAMMPS *lmp, int narg, char **arg) : + FixNH(lmp, narg, arg_kludge(narg,arg,rem)) +{ + + //initialization + erate[0] = erate[1] = 0; + //default values + strain[0]=strain[1]= 0; + ext_flags[0]=ext_flags[1]=ext_flags[2] = true; + + // need to initialize these + omega_dot[0]=omega_dot[1]=omega_dot[2]=0; + + // parse remaining input + bool erate_flag = false; + int iarg = narg; + narg += rem; + while (iarg <narg) + { + if (strcmp(arg[iarg],"erate")==0) { + if (iarg+3 > narg) error->all(FLERR,"Illegal fix nvt/npt/uef command"); + erate[0] = force->numeric(FLERR,arg[iarg+1]); + erate[1] = force->numeric(FLERR,arg[iarg+2]); + erate_flag = true; + iarg += 3; + } + else if (strcmp(arg[iarg],"strain")==0) { + if (iarg+3 > narg) error->all(FLERR,"Illegal fix nvt/npt/uef command"); + strain[0] = force->numeric(FLERR,arg[iarg+1]); + strain[1] = force->numeric(FLERR,arg[iarg+2]); + iarg += 3; + } + else if (strcmp(arg[iarg],"ext")==0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix nvt/npt/uef command"); + if (strcmp(arg[iarg+1],"x")==0) + ext_flags[1] = ext_flags[2] = false; + else if (strcmp(arg[iarg+1],"y")==0) + ext_flags[0] = ext_flags[2] = false; + else if (strcmp(arg[iarg+1],"z")==0) + ext_flags[0] = ext_flags[1] = false; + else if (strcmp(arg[iarg+1],"xy")==0) + ext_flags[2] = false; + else if (strcmp(arg[iarg+1],"xz")==0) + ext_flags[1] = false; + else if (strcmp(arg[iarg+1],"yz")==0) + ext_flags[0] = false; + else if (strcmp(arg[iarg+1],"xyz")!=0) + error->all(FLERR,"Illegal fix nvt/npt/uef command"); + + iarg += 2; + } + else + error->all(FLERR,"Illegal fix nvt/npt/uef command"); + } + if (!erate_flag) + error->all(FLERR,"Keyword erate must be set for fix npt/npt/uef command"); + + if (mtchain_default_flag) mtchain=1; + + if (!domain->triclinic) + error->all(FLERR,"Simulation box must be triclinic for fix/nvt/npt/uef"); + + //check for conditions that impose a deviatoric stress + if (pstyle == TRICLINIC) + error->all(FLERR,"Only normal stresses can be controlled with fix/nvt/npt/uef"); + double erate_tmp[3]; + erate_tmp[0]=erate[0]; + erate_tmp[1]=erate[1]; + erate_tmp[2]=-erate[0]-erate[1]; + + if (pstyle == ANISO) + { + if (!(ext_flags[0] & ext_flags[1] & ext_flags[2])) + error->all(FLERR,"The ext keyword may only be used with iso pressure control"); + for (int k=0;k<3;k++) + for (int j=0;j<3;j++) + if (p_flag[k] && p_flag[j]) + { + double tol = 1e-6; + if ( !nearly_equal(p_start[k],p_start[j],tol) || !nearly_equal(p_stop[k],p_stop[j],tol)) + error->all(FLERR,"All controlled stresses must have the same value in fix/nvt/npt/uef"); + if ( !nearly_equal(erate_tmp[k],erate_tmp[j],tol) || !nearly_equal(erate_tmp[k],erate_tmp[j],tol)) + error->all(FLERR,"Dimensions with controlled stresses must have same strain rate in fix/nvt/npt/uef"); + } + } + // conditions that produce a deviatoric stress have already + // been eliminated. + deviatoric_flag=0; + + // need pre_exchange and irregular migration + pre_exchange_flag = 1; + irregular = new Irregular(lmp); + + // flag that I change the box here (in case of nvt) + box_change_shape = 1; + + // initialize the UEFBox class which computes the box at each step + uefbox = new UEF_utils::UEFBox(); + uefbox->set_strain(strain[0],strain[1]); + + // reset fixedpoint to the stagnation point. I don't allow fixedpoint + // to be set by the user. + fixedpoint[0] = domain->boxlo[0]; + fixedpoint[1] = domain->boxlo[1]; + fixedpoint[2] = domain->boxlo[2]; + + // Create temp and pressure computes for uef + int n = strlen(id) + 6; + id_temp = new char[n]; + strcpy(id_temp,id); + strcat(id_temp,"_temp"); + char **newarg = new char*[3]; + newarg[0] = id_temp; + newarg[1] = (char *) "all"; + newarg[2] = (char *) "temp/uef"; + modify->add_compute(3,newarg); + delete [] newarg; + tcomputeflag = 1; + n = strlen(id) + 7; + id_press = new char[n]; + strcpy(id_press,id); + strcat(id_press,"_press"); + newarg = new char*[4]; + newarg[0] = id_press; + newarg[1] = (char *) "all"; + newarg[2] = (char *) "pressure/uef"; + newarg[3] = id_temp; + modify->add_compute(4,newarg); + delete [] newarg; + pcomputeflag = 1; + + nevery = 1; + + +} + +/* ---------------------------------------------------------------------- + * Erase the UEFBox object and get rid of the pressure compute if the nvt + * version is being used. Everything else will be done in base destructor + * ---------------------------------------------------------------------- */ +FixNHUef::~FixNHUef() +{ + delete uefbox; + if (pcomputeflag && !pstat_flag) + { + modify->delete_compute(id_press); + delete [] id_press; + } +} + +/* ---------------------------------------------------------------------- + * Make the end_of_step() routine callable + * ---------------------------------------------------------------------- */ +int FixNHUef::setmask() +{ + int mask = FixNH::setmask(); + mask |= END_OF_STEP; + return mask; +} + +/* ---------------------------------------------------------------------- + * Run FixNH::init() and do more error checking. Set the pressure + * pointer in the case that the nvt version is used + * ---------------------------------------------------------------------- */ +void FixNHUef::init() +{ + FixNH::init(); + + + // find conflict with fix/deform or other box chaging fixes + for (int i=0; i < modify->nfix; i++) + { + if (strcmp(modify->fix[i]->id,id) != 0) + if (modify->fix[i]->box_change_shape != 0) + error->all(FLERR,"Can't use another fix which changes box shape with fix/nvt/npt/uef"); + } + + + // this will make the pressure compute for nvt + if (!pstat_flag) + if (pcomputeflag) + { + int icomp = modify->find_compute(id_press); + if (icomp<0) + error->all(FLERR,"Pressure ID for fix/nvt/uef doesn't exist"); + pressure = modify->compute[icomp]; + + } + if (strcmp(pressure->style,"pressure/uef") != 0) + error->all(FLERR,"Using fix nvt/npt/uef without a compute pressure/uef"); + if (strcmp(temperature->style,"temp/uef") != 0) + error->all(FLERR,"Using fix nvt/npt/uef without a compute temp/uef"); + +} + +/* ---------------------------------------------------------------------- + * Run FixNH::setup() make sure the box is OK and set the rotation matrix + * for the first step + * ---------------------------------------------------------------------- */ +void FixNHUef::setup(int j) +{ + double box[3][3]; + double vol = domain->xprd * domain->yprd * domain->zprd; + uefbox->get_box(box,vol); + double tol = 1e-4; + // ensure the box is ok for uef + bool isok = true; + isok &= nearly_equal(domain->h[0],box[0][0],tol); + isok &= nearly_equal(domain->h[1],box[1][1],tol); + isok &= nearly_equal(domain->h[2],box[2][2],tol); + isok &= nearly_equal(domain->xy,box[0][1],tol); + isok &= nearly_equal(domain->yz,box[1][2],tol); + isok &= nearly_equal(domain->xz,box[0][2],tol); + if (!isok) + error->all(FLERR,"Initial box is not close enough to the expected uef box"); + + uefbox->get_rot(rot); + ((ComputeTempUef*) temperature)->yes_rot(); + ((ComputePressureUef*) pressure)->in_fix = true; + ((ComputePressureUef*) pressure)->update_rot(); + FixNH::setup(j); +} + +/* ---------------------------------------------------------------------- + * rotate -> initial integration step -> rotate back + * ---------------------------------------------------------------------- */ +void FixNHUef::initial_integrate(int vflag) +{ + inv_rotate_x(rot); + inv_rotate_v(rot); + inv_rotate_f(rot); + ((ComputeTempUef*) temperature)->no_rot(); + FixNH::initial_integrate(vflag); + rotate_x(rot); + rotate_v(rot); + rotate_f(rot); + ((ComputeTempUef*) temperature)->yes_rot(); +} + +/* ---------------------------------------------------------------------- + * rotate -> initial integration step -> rotate back (RESPA) + * ---------------------------------------------------------------------- */ +void FixNHUef::initial_integrate_respa(int vflag, int ilevel, int iloop) +{ + inv_rotate_x(rot); + inv_rotate_v(rot); + inv_rotate_f(rot); + ((ComputeTempUef*) temperature)->no_rot(); + FixNH::initial_integrate_respa(vflag,ilevel,iloop); + rotate_x(rot); + rotate_v(rot); + rotate_f(rot); + ((ComputeTempUef*) temperature)->yes_rot(); +} + +/* ---------------------------------------------------------------------- + * rotate -> final integration step -> rotate back + * ---------------------------------------------------------------------- */ +void FixNHUef::final_integrate() +{ + // update rot here since it must directly follow the virial calculation + ((ComputePressureUef*) pressure)->update_rot(); + inv_rotate_v(rot); + inv_rotate_f(rot); + ((ComputeTempUef*) temperature)->no_rot(); + FixNH::final_integrate(); + rotate_v(rot); + rotate_f(rot); + ((ComputeTempUef*) temperature)->yes_rot(); +} + +/* ---------------------------------------------------------------------- + * at outer level: call this->final_integrate() + * at other levels: rotate -> 2nd verlet step -> rotate back + * ---------------------------------------------------------------------- */ +void FixNHUef::final_integrate_respa(int ilevel, int iloop) +{ + // set timesteps by level + dtf = 0.5 * step_respa[ilevel] * force->ftm2v; + dthalf = 0.5 * step_respa[ilevel]; + // outermost level - update eta_dot and omega_dot, apply via final_integrate + // all other levels - NVE update of v + if (ilevel == nlevels_respa-1) final_integrate(); + else + { + inv_rotate_v(rot); + inv_rotate_f(rot); + nve_v(); + rotate_v(rot); + rotate_f(rot); + } +} + +/* ---------------------------------------------------------------------- + SLLOD velocity update in time-reversible (i think) increments + v -> exp(-edot*dt/2)*v + v -> v +f/m*dt + v -> exp(-edot*dt/2)*v +-----------------------------------------------------------------------*/ +void FixNHUef::nve_v() +{ + double dtfm; + double **v = atom->v; + double **f = atom->f; + double *rmass = atom->rmass; + double *mass = atom->mass; + int *type = atom->type; + int *mask = atom->mask; + int nlocal = atom->nlocal; + double ex = erate[0]*dtf/2; + double ey = erate[1]*dtf/2; + double ez = -ex-ey; + double e0 = exp(-ex); + double e1 = exp(-ey); + double e2 = exp(-ez); + if (igroup == atom->firstgroup) nlocal = atom->nfirst; + + if (rmass) { + for (int i = 0; i < nlocal; i++) { + if (mask[i] & groupbit) { + dtfm = dtf / rmass[i]; + v[i][0] *= e0; + v[i][1] *= e1; + v[i][2] *= e2; + v[i][0] += dtfm*f[i][0]; + v[i][1] += dtfm*f[i][1]; + v[i][2] += dtfm*f[i][2]; + v[i][0] *= e0; + v[i][1] *= e1; + v[i][2] *= e2; + } + } + } else { + for (int i = 0; i < nlocal; i++) { + if (mask[i] & groupbit) { + dtfm = dtf / mass[type[i]]; + v[i][0] *= e0; + v[i][1] *= e1; + v[i][2] *= e2; + v[i][0] += dtfm*f[i][0]; + v[i][1] += dtfm*f[i][1]; + v[i][2] += dtfm*f[i][2]; + v[i][0] *= e0; + v[i][1] *= e1; + v[i][2] *= e2; + } + } + } +} + +/* ---------------------------------------------------------------------- + Don't actually move atoms in remap(), just change the box +-----------------------------------------------------------------------*/ +void FixNHUef::remap() +{ + double vol = domain->xprd * domain->yprd * domain->zprd; + double domega = dto*(omega_dot[0]+omega_dot[1]+omega_dot[2])/3.; + + // constant volume strain associated with barostat + // box scaling + double ex = dto*omega_dot[0]-domega; + double ey = dto*omega_dot[1]-domega; + uefbox->step_deform(ex,ey); + strain[0] += ex; + strain[1] += ey; + + // volume change + vol = vol*exp(3*domega); + double box[3][3]; + uefbox->get_box(box,vol); + domain->boxhi[0] = domain->boxlo[0]+box[0][0]; + domain->boxhi[1] = domain->boxlo[1]+box[1][1]; + domain->boxhi[2] = domain->boxlo[2]+box[2][2]; + domain->xy = box[0][1]; + domain->xz = box[0][2]; + domain->yz = box[1][2]; + domain->set_global_box(); + domain->set_local_box(); + uefbox->get_rot(rot); +} + +/* ---------------------------------------------------------------------- + SLLOD position update in time-reversible (i think) increments + x -> exp(edot*dt/2)*x + x -> x + v*dt + x -> exp(edot*dt/2)*x +-----------------------------------------------------------------------*/ +void FixNHUef::nve_x() +{ + double **x = atom->x; + double **v = atom->v; + int *mask = atom->mask; + int nlocal = atom->nlocal; + double ex = erate[0]*dtv; + strain[0] += ex; + double e0 = exp((ex+omega_dot[0]*dtv)/2); + double ey = erate[1]*dtv; + strain[1] += ey; + double e1 = exp((ey+omega_dot[1]*dtv)/2.); + double ez = -ex -ey; + double e2 = exp((ez+omega_dot[2]*dtv)/2.); + if (igroup == atom->firstgroup) nlocal = atom->nfirst; + + // x update by full step only for atoms in group + for (int i = 0; i < nlocal; i++) { + if (mask[i] & groupbit) { + x[i][0] *= e0; + x[i][1] *= e1; + x[i][2] *= e2; + x[i][0] += dtv * v[i][0]; + x[i][1] += dtv * v[i][1]; + x[i][2] += dtv * v[i][2]; + x[i][0] *= e0; + x[i][1] *= e1; + x[i][2] *= e2; + } + } + uefbox->step_deform(ex,ey); + double box[3][3]; + double vol = domain->xprd * domain->yprd * domain->zprd; + uefbox->get_box(box,vol); + domain->boxhi[0] = domain->boxlo[0]+box[0][0]; + domain->boxhi[1] = domain->boxlo[1]+box[1][1]; + domain->boxhi[2] = domain->boxlo[2]+box[2][2]; + domain->xy = box[0][1]; + domain->xz = box[0][2]; + domain->yz = box[1][2]; + domain->set_global_box(); + domain->set_local_box(); + uefbox->get_rot(rot); +} + +/* ---------------------------------------------------------------------- + * Do the lattice reduction if necessary. +-----------------------------------------------------------------------*/ +void FixNHUef::pre_exchange() +{ + // only need to reset things if the lattice needs to be reduced + if (uefbox->reduce()) + { + // go to lab frame + inv_rotate_x(rot); + inv_rotate_v(rot); + inv_rotate_f(rot); + // get & set the new box and rotation matrix + double vol = domain->xprd * domain->yprd * domain->zprd; + double box[3][3]; + uefbox->get_box(box,vol); + domain->boxhi[0] = domain->boxlo[0]+box[0][0]; + domain->boxhi[1] = domain->boxlo[1]+box[1][1]; + domain->boxhi[2] = domain->boxlo[2]+box[2][2]; + domain->xy = box[0][1]; + domain->xz = box[0][2]; + domain->yz = box[1][2]; + domain->set_global_box(); + domain->set_local_box(); + uefbox->get_rot(rot); + + // rotate to the new upper triangular frame + rotate_v(rot); + rotate_x(rot); + rotate_f(rot); + + // put all atoms in the new box + double **x = atom->x; + imageint *image = atom->image; + int nlocal = atom->nlocal; + for (int i=0; i<nlocal; i++) domain->remap(x[i],image[i]); + + // move atoms to the right processors + domain->x2lamda(atom->nlocal); + irregular->migrate_atoms(); + domain->lamda2x(atom->nlocal); + } +} + +/* ---------------------------------------------------------------------- + * The following are routines to rotate between the lab and upper triangular + * (UT) frames. For most of the time the simulation is in the UT frame. + * To get to the lab frame, apply the inv_rotate_[..](rot) and to + * get back to the UT frame apply rotate_[..](rot). + * + * Note: the rotate_x() functions also apply a shift to/from the fixedpoint + * to make the integration a little simpler. + * ---------------------------------------------------------------------- */ +void FixNHUef::rotate_x(double r[3][3]) +{ + double **x = atom->x; + int *mask = atom->mask; + int nlocal = atom->nlocal; + if (igroup == atom->firstgroup) nlocal = atom->nfirst; + + double xn[3]; + for (int i=0;i<nlocal;i++) + { + if (mask[i] & groupbit) + { + xn[0]=r[0][0]*x[i][0]+r[0][1]*x[i][1]+r[0][2]*x[i][2]; + xn[1]=r[1][0]*x[i][0]+r[1][1]*x[i][1]+r[1][2]*x[i][2]; + xn[2]=r[2][0]*x[i][0]+r[2][1]*x[i][1]+r[2][2]*x[i][2]; + x[i][0]=xn[0]+domain->boxlo[0]; + x[i][1]=xn[1]+domain->boxlo[1]; + x[i][2]=xn[2]+domain->boxlo[2]; + } + } +} + +void FixNHUef::inv_rotate_x(double r[3][3]) +{ + double **x = atom->x; + int *mask = atom->mask; + int nlocal = atom->nlocal; + if (igroup == atom->firstgroup) nlocal = atom->nfirst; + + double xn[3]; + for (int i=0;i<nlocal;i++) + { + if (mask[i] & groupbit) + { + x[i][0] -= domain->boxlo[0]; + x[i][1] -= domain->boxlo[1]; + x[i][2] -= domain->boxlo[2]; + xn[0]=r[0][0]*x[i][0]+r[1][0]*x[i][1]+r[2][0]*x[i][2]; + xn[1]=r[0][1]*x[i][0]+r[1][1]*x[i][1]+r[2][1]*x[i][2]; + xn[2]=r[0][2]*x[i][0]+r[1][2]*x[i][1]+r[2][2]*x[i][2]; + x[i][0]=xn[0]; + x[i][1]=xn[1]; + x[i][2]=xn[2]; + } + } +} + +void FixNHUef::rotate_v(double r[3][3]) +{ + double **v = atom->v; + int *mask = atom->mask; + int nlocal = atom->nlocal; + if (igroup == atom->firstgroup) nlocal = atom->nfirst; + + double vn[3]; + for (int i=0;i<nlocal;i++) + { + if (mask[i] & groupbit) + { + vn[0]=r[0][0]*v[i][0]+r[0][1]*v[i][1]+r[0][2]*v[i][2]; + vn[1]=r[1][0]*v[i][0]+r[1][1]*v[i][1]+r[1][2]*v[i][2]; + vn[2]=r[2][0]*v[i][0]+r[2][1]*v[i][1]+r[2][2]*v[i][2]; + v[i][0]=vn[0]; v[i][1]=vn[1]; v[i][2]=vn[2]; + } + } +} + +void FixNHUef::inv_rotate_v(double r[3][3]) +{ + double **v = atom->v; + int *mask = atom->mask; + int nlocal = atom->nlocal; + if (igroup == atom->firstgroup) nlocal = atom->nfirst; + + double vn[3]; + for (int i=0;i<nlocal;i++) + { + if (mask[i] & groupbit) + { + vn[0]=r[0][0]*v[i][0]+r[1][0]*v[i][1]+r[2][0]*v[i][2]; + vn[1]=r[0][1]*v[i][0]+r[1][1]*v[i][1]+r[2][1]*v[i][2]; + vn[2]=r[0][2]*v[i][0]+r[1][2]*v[i][1]+r[2][2]*v[i][2]; + v[i][0]=vn[0]; v[i][1]=vn[1]; v[i][2]=vn[2]; + } + } +} + +void FixNHUef::rotate_f(double r[3][3]) +{ + double **f = atom->f; + int *mask = atom->mask; + int nlocal = atom->nlocal; + if (igroup == atom->firstgroup) nlocal = atom->nfirst; + + double fn[3]; + for (int i=0;i<nlocal;i++) + { + if (mask[i] & groupbit) + { + fn[0]=r[0][0]*f[i][0]+r[0][1]*f[i][1]+r[0][2]*f[i][2]; + fn[1]=r[1][0]*f[i][0]+r[1][1]*f[i][1]+r[1][2]*f[i][2]; + fn[2]=r[2][0]*f[i][0]+r[2][1]*f[i][1]+r[2][2]*f[i][2]; + f[i][0]=fn[0]; f[i][1]=fn[1]; f[i][2]=fn[2]; + } + } +} + +void FixNHUef::inv_rotate_f(double r[3][3]) +{ + double **f = atom->f; + int *mask = atom->mask; + int nlocal = atom->nlocal; + if (igroup == atom->firstgroup) nlocal = atom->nfirst; + double fn[3]; + for (int i=0;i<nlocal;i++) + { + if (mask[i] & groupbit) + { + fn[0]=r[0][0]*f[i][0]+r[1][0]*f[i][1]+r[2][0]*f[i][2]; + fn[1]=r[0][1]*f[i][0]+r[1][1]*f[i][1]+r[2][1]*f[i][2]; + fn[2]=r[0][2]*f[i][0]+r[1][2]*f[i][1]+r[2][2]*f[i][2]; + f[i][0]=fn[0]; f[i][1]=fn[1]; f[i][2]=fn[2]; + } + } +} + +/* ---------------------------------------------------------------------- + * Increase the size of the restart list to add in the strains + * ---------------------------------------------------------------------- */ +int FixNHUef::size_restart_global() +{ + return FixNH::size_restart_global() +2; +} + +/* ---------------------------------------------------------------------- + * Pack the strains after packing the default FixNH values + * ---------------------------------------------------------------------- */ +int FixNHUef::pack_restart_data(double *list) +{ + int n = FixNH::pack_restart_data(list); + list[n++] = strain[0]; + list[n++] = strain[1]; + return n; +} + +/* ---------------------------------------------------------------------- + * read and set the strains after the default FixNH values + * ---------------------------------------------------------------------- */ +void FixNHUef::restart(char *buf) +{ + int n = size_restart_global(); + FixNH::restart(buf); + double *list = (double *) buf; + strain[0] = list[n-2]; + strain[1] = list[n-1]; + uefbox->set_strain(strain[0],strain[1]); +} + +/* ---------------------------------------------------------------------- + * If the step writes a restart, reduce the box beforehand. This makes sure + * the unique box shape can be found once the restart is read and that + * all of the atoms lie within the box. + * This may only be necessary for RESPA runs, but I'm leaving it in anyway. + * ---------------------------------------------------------------------- */ +void FixNHUef::end_of_step() +{ + if (update->ntimestep==output->next_restart) + { + pre_exchange(); + domain->x2lamda(atom->nlocal); + domain->pbc(); + timer->stamp(); + comm->exchange(); + comm->borders(); + domain->lamda2x(atom->nlocal+atom->nghost); + timer->stamp(Timer::COMM); + neighbor->build(); + timer->stamp(Timer::NEIGH); + } +} + +/* ---------------------------------------------------------------------- + * reduce the simulation box after a run is complete. otherwise it won't + * be possible to resume from a write_restart since the initialization of + * the simulation box requires reduced simulation box + * ---------------------------------------------------------------------- */ +void FixNHUef::post_run() +{ + pre_exchange(); + domain->x2lamda(atom->nlocal); + domain->pbc(); + timer->stamp(); + comm->exchange(); + comm->borders(); + domain->lamda2x(atom->nlocal+atom->nghost); + timer->stamp(Timer::COMM); + neighbor->build(); + timer->stamp(Timer::NEIGH); +} + +/* ---------------------------------------------------------------------- + * public read for rotation matrix + * ---------------------------------------------------------------------- */ +void FixNHUef::get_rot(double r[3][3]) +{ + r[0][0] = rot[0][0]; + r[0][1] = rot[0][1]; + r[0][2] = rot[0][2]; + r[1][0] = rot[1][0]; + r[1][1] = rot[1][1]; + r[1][2] = rot[1][2]; + r[2][0] = rot[2][0]; + r[2][1] = rot[2][1]; + r[2][2] = rot[2][2]; +} + +/* ---------------------------------------------------------------------- + * public read for ext flags + * ---------------------------------------------------------------------- */ +void FixNHUef::get_ext_flags(bool* e) +{ + e[0] = ext_flags[0]; + e[1] = ext_flags[1]; + e[2] = ext_flags[2]; +} + +/* ---------------------------------------------------------------------- + * public read for simulation box + * ---------------------------------------------------------------------- */ +void FixNHUef::get_box(double b[3][3]) +{ + double box[3][3]; + double vol = domain->xprd * domain->yprd * domain->zprd; + uefbox->get_box(box,vol); + b[0][0] = box[0][0]; + b[0][1] = box[0][1]; + b[0][2] = box[0][2]; + b[1][0] = box[1][0]; + b[1][1] = box[1][1]; + b[1][2] = box[1][2]; + b[2][0] = box[2][0]; + b[2][1] = box[2][1]; + b[2][2] = box[2][2]; +} + +/* ---------------------------------------------------------------------- + * comparing floats + * it's imperfect, but should work provided no infinities + * ---------------------------------------------------------------------- */ +bool FixNHUef::nearly_equal(double a, double b, double epsilon) +{ + double absa = fabs(a); + double absb = fabs(b); + double diff = fabs(a-b); + if (a == b) return true; + else if ( (absa+absb) < epsilon) + return diff < epsilon*epsilon; + else + return diff/(absa+absb) < epsilon; +} diff --git a/src/USER-UEF/fix_nh_uef.h b/src/USER-UEF/fix_nh_uef.h new file mode 100644 index 0000000000000000000000000000000000000000..46916005a3e1d71f4d24a0e64136132d6506c762 --- /dev/null +++ b/src/USER-UEF/fix_nh_uef.h @@ -0,0 +1,125 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + www.cs.sandia.gov/~sjplimp/lammps.html + Steve Plimpton, sjplimp@sandia.gov, Sandia National Laboratories + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. + + Contributing Author: David Nicholson (MIT) +------------------------------------------------------------------------- */ + + +#ifndef LMP_FIX_NH_UEF_H +#define LMP_FIX_NH_UEF_H + +#include "uef_utils.h" +#include "fix_nh.h" + +namespace LAMMPS_NS { +class FixNHUef : public FixNH { + public: + FixNHUef(class LAMMPS *, int, char **); + virtual ~FixNHUef(); + virtual int setmask(); + virtual void init(); + virtual void setup(int); + virtual void pre_exchange(); + virtual int pack_restart_data(double*); + virtual void restart(char *); + virtual void end_of_step(); + virtual void initial_integrate(int); + virtual void final_integrate(); + virtual void initial_integrate_respa(int, int, int); + virtual void final_integrate_respa(int, int); + virtual void post_run(); + void get_rot(double[3][3]); + void get_ext_flags(bool*); + void get_box(double[3][3]); + + protected: + virtual void remap(); + virtual int size_restart_global(); + virtual void nve_x(); + virtual void nve_v(); + char **arg_kludge(int&, char**, int&); + void rotate_x(double [3][3]); + void inv_rotate_x(double[3][3]); + void rotate_v(double[3][3]); + void inv_rotate_v(double[3][3]); + void rotate_f(double[3][3]); + void inv_rotate_f(double[3][3]); + double strain[2],erate[2]; // strain/strain rate : [e_x, e_y] + // always assume traceless e_z = -e_x-e_y + + int rem; //this is for the narg kluge + + UEF_utils::UEFBox *uefbox; // interface for the special simulation box + + double rot[3][3]; // rotation matrix + bool ext_flags[3]; // flags for external "free surfaces" + bool nearly_equal(double,double,double); + //bool rotate_output; // experimental feature. Too many issues for now +}; + +} + +#endif + +/* ERROR/WARNING messages: + +This is a base class for FixNH so it will inherit most of its error/warning messages along with the following: + +E: Illegal fix nvt/npt/uef command + +Self-explanatory + +E: Keyword erate must be set for fix nvt/npt/uef command + +Self-explanatory. + +E: Simulation box must be triclinic for fix/nvt/npt/uef + +Self-explanatory. + +E: Only normal stresses can be controlled with fix/nvt/npt/uef + +The keywords xy xz and yz cannot be used for pressure control + +E: The ext keyword may only be used with iso pressure control + +Self-explanatory + +E: All controlled stresses must have the same value in fix/nvt/npt/uef + +Stress control is only possible when the stress specified for each dimension is the same + +E: Dimensions with controlled stresses must have same strain rate in fix/nvt/npt/uef + +Stress-controlled dimensions with the same strain rate must have the same target stress. + +E: Can't use another fix which changes box shape with fix/nvt/npt/uef + +The fix npt/nvt/uef command must have full control over the box shape. You cannot use a simultaneous fix deform command, for example. + +E: Pressure ID for fix/nvt/uef doesn't exist + +The compute pressure introduced via fix_modify does not exist + +E: Using fix nvt/npt/uef without a compute pressure/uef + +Self-explanatory. + +E: Using fix nvt/npt/uef without a compute temp/uef + +Self-explanatory. + +E: Initial box is not close enough to the expected uef box + +The initial box does not correspond to the shape required by the value of the strain keyword. If the default strain value of zero was used, the initial box is not cubic. + +*/ diff --git a/src/USER-UEF/fix_npt_uef.cpp b/src/USER-UEF/fix_npt_uef.cpp new file mode 100644 index 0000000000000000000000000000000000000000..1bf027bf85fddc42e0922647348b2208a27579e0 --- /dev/null +++ b/src/USER-UEF/fix_npt_uef.cpp @@ -0,0 +1,33 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. + + Contributing author: David Nicholson (MIT) +------------------------------------------------------------------------- */ + +#include "string.h" +#include "fix_npt_uef.h" +#include "modify.h" +#include "error.h" + +using namespace LAMMPS_NS; +using namespace FixConst; + + +FixNPTUef::FixNPTUef(LAMMPS *lmp, int narg, char **arg) : + FixNHUef(lmp, narg, arg) +{ + if (!tstat_flag) + error->all(FLERR,"Temperature control must be used with fix npt/uef"); + if (!pstat_flag) + error->all(FLERR,"Pressure control must be used with fix npt/uef"); + +} diff --git a/src/USER-UEF/fix_npt_uef.h b/src/USER-UEF/fix_npt_uef.h new file mode 100644 index 0000000000000000000000000000000000000000..a77060a93714a1a0e9b169166691a3ff595450ed --- /dev/null +++ b/src/USER-UEF/fix_npt_uef.h @@ -0,0 +1,50 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. + + Contributing author: David Nicholson (MIT) +------------------------------------------------------------------------- */ + +#ifdef FIX_CLASS + +FixStyle(npt/uef,FixNPTUef) + +#else + +#ifndef LMP_FIX_NPT_UEF_H +#define LMP_FIX_NPT_UEF_H + +#include "fix_nh_uef.h" + +namespace LAMMPS_NS { + +class FixNPTUef : public FixNHUef { + public: + FixNPTUef(class LAMMPS *, int, char **); + ~FixNPTUef() {} +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Temperature control must be used with fix npt uef + +Self-explanatory. + +E: Pressure control must be used with fix npt uef + +Self-explanatory. + +*/ diff --git a/src/USER-UEF/fix_nvt_uef.cpp b/src/USER-UEF/fix_nvt_uef.cpp new file mode 100644 index 0000000000000000000000000000000000000000..589a4b5b566587276a8582ef612c44c9922adbe8 --- /dev/null +++ b/src/USER-UEF/fix_nvt_uef.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. + + Contributing author: David Nicholson (MIT) +------------------------------------------------------------------------- */ + +#include "string.h" +#include "fix_nvt_uef.h" +#include "modify.h" +#include "error.h" + +using namespace LAMMPS_NS; +using namespace FixConst; + + +FixNVTUef::FixNVTUef(LAMMPS *lmp, int narg, char **arg) : + FixNHUef(lmp, narg, arg) +{ + if (!tstat_flag) + error->all(FLERR,"Temperature control must be used with fix nvt/uef"); + if (pstat_flag) + error->all(FLERR,"Pressure control can't be used with fix nvt/uef"); + +} + + diff --git a/src/USER-UEF/fix_nvt_uef.h b/src/USER-UEF/fix_nvt_uef.h new file mode 100644 index 0000000000000000000000000000000000000000..a6eba7a284ee3afcb2d811ce0ad5ec8e4d5a813c --- /dev/null +++ b/src/USER-UEF/fix_nvt_uef.h @@ -0,0 +1,50 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. + + Contributing author: David Nicholson (MIT) +------------------------------------------------------------------------- */ + +#ifdef FIX_CLASS + +FixStyle(nvt/uef,FixNVTUef) + +#else + +#ifndef LMP_FIX_NVT_UEF_H +#define LMP_FIX_NVT_UEF_H + +#include "fix_nh_uef.h" + +namespace LAMMPS_NS { + +class FixNVTUef : public FixNHUef { + public: + FixNVTUef(class LAMMPS *, int, char **); + ~FixNVTUef(){} +}; + +} + +#endif +#endif + +/* ERROR/WARNING messages: + +E: Temperature control must be used with fix npt uef + +Self-explanatory. + +E: Pressure control must be used with fix npt uef + +Self-explanatory. + +*/ diff --git a/src/USER-UEF/uef_utils.cpp b/src/USER-UEF/uef_utils.cpp new file mode 100644 index 0000000000000000000000000000000000000000..93bbd2b77db5ce7723367d4eaefbdee730e1efb5 --- /dev/null +++ b/src/USER-UEF/uef_utils.cpp @@ -0,0 +1,365 @@ +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. + + Contributing author: David Nicholson (MIT) +------------------------------------------------------------------------- + + This class contains functions to calculate the evolution of the periodic + simulation box under elongational flow as described by Matthew Dobson + in the arXiv preprint at http://arxiv.org/abs/1408.7078 + + Additionally, there are methods to do a lattice reduction to further + reduce the simulation box using the method of Igor Semaev at + http://link.springer.com/chapter/10.1007%2F3-540-44670-2_13 +*/ +#include <math.h> +#include "uef_utils.h" + +using namespace LAMMPS_NS; +using namespace UEF_utils; + +UEFBox::UEFBox() +{ + // initial box (also an inverse eigenvector matrix of automorphisms) + double x = 0.327985277605681; + double y = 0.591009048506103; + double z = 0.736976229099578; + l0[0][0]= z; l0[0][1]= y; l0[0][2]= x; + l0[1][0]=-x; l0[1][1]= z; l0[1][2]=-y; + l0[2][0]=-y; l0[2][1]= x; l0[2][2]= z; + // spectra of the two automorpisms (log of eigenvalues) + w1[0]=-1.177725211523360; + w1[1]=-0.441448620566067; + w1[2]= 1.619173832089425; + w2[0]= w1[1]; + w2[1]= w1[2]; + w2[2]= w1[0]; + // initialize theta + // strain = w1 * theta1 + w2 * theta2 + theta[0]=theta[1]=0; + + + //set up the initial box l and change of basis matrix r + for (int k=0;k<3;k++) + for (int j=0;j<3;j++) + { + l[k][j] = l0[k][j]; + r[j][k]=(j==k); + } + + // get the initial rotation and upper triangular matrix + rotation_matrix(rot, lrot ,l); + + // this is just a way to calculate the automorphisms + // themselves, which play a minor role in the calculations + // it's overkill, but only called once + double t1[3][3]; + double t1i[3][3]; + double t2[3][3]; + double t2i[3][3]; + double l0t[3][3]; + for (int k=0; k<3; ++k) + for (int j=0; j<3; ++j) + { + t1[k][j] = exp(w1[k])*l0[k][j]; + t1i[k][j] = exp(-w1[k])*l0[k][j]; + t2[k][j] = exp(w2[k])*l0[k][j]; + t2i[k][j] = exp(-w2[k])*l0[k][j]; + l0t[k][j] = l0[j][k]; + } + mul_m2(l0t,t1); + mul_m2(l0t,t1i); + mul_m2(l0t,t2); + mul_m2(l0t,t2i); + for (int k=0; k<3; ++k) + for (int j=0; j<3; ++j) + { + a1[k][j] = round(t1[k][j]); + a1i[k][j] = round(t1i[k][j]); + a2[k][j] = round(t2[k][j]); + a2i[k][j] = round(t2i[k][j]); + } + + // winv used to transform between + // strain increments and theta increments + winv[0][0] = w2[1]; + winv[0][1] = -w2[0]; + winv[1][0] = -w1[1]; + winv[1][1] = w1[0]; + double d = w1[0]*w2[1] - w2[0]*w1[1]; + for (int k=0;k<2;k++) + for (int j=0;j<2;j++) + winv[k][j] /= d; +} + +// get volume-correct r basis in: basis*cbrt(vol) = q*r +void UEFBox::get_box(double x[3][3], double v) +{ + v = cbrtf(v); + for (int k=0;k<3;k++) + for (int j=0;j<3;j++) + x[k][j] = lrot[k][j]*v; +} + +// get rotation matrix q in: basis = q*r +void UEFBox::get_rot(double x[3][3]) +{ + for (int k=0;k<3;k++) + for (int j=0;j<3;j++) + x[k][j]=rot[k][j]; +} + +// diagonal, incompressible deformation +void UEFBox::step_deform(const double ex, const double ey) +{ + // increment theta values used in the reduction + theta[0] +=winv[0][0]*ex + winv[0][1]*ey; + theta[1] +=winv[1][0]*ex + winv[1][1]*ey; + + // deformation of the box. reduce() needs to + // be called regularly or calculation will become + // unstable + double eps[3]; + eps[0]=ex; eps[1] = ey; eps[2] = -ex-ey; + for (int k=0;k<3;k++) + { + eps[k] = exp(eps[k]); + l[k][0] = eps[k]*l[k][0]; + l[k][1] = eps[k]*l[k][1]; + l[k][2] = eps[k]*l[k][2]; + } + rotation_matrix(rot,lrot, l); +} +// reuduce the current basis +bool UEFBox::reduce() +{ + // determine how many times to apply the automorphisms + // and find new theta values + int f1 = round(theta[0]); + int f2 = round(theta[1]); + theta[0] -= f1; + theta[1] -= f2; + + // store old change or basis matrix to determine if it + // changes + int r0[3][3]; + for (int k=0;k<3;k++) + for (int j=0;j<3;j++) + r0[k][j]=r[k][j]; + + // this modifies the old change basis matrix to + // handle the case where the automorphism transforms + // the box but the reduced basis doesn't change + // (r0 should still equal r at the end) + if (f1 > 0) for (int k=0;k<f1;k++) mul_m2 (a1,r0); + if (f1 < 0) for (int k=0;k<-f1;k++) mul_m2 (a1i,r0); + if (f2 > 0) for (int k=0;k<f2;k++) mul_m2 (a2,r0); + if (f2 < 0) for (int k=0;k<-f2;k++) mul_m2 (a2i,r0); + + // robust reduction to the box defined by Dobson + for (int k=0;k<3;k++) + { + double eps = exp(theta[0]*w1[k]+theta[1]*w2[k]); + l[k][0] = eps*l0[k][0]; + l[k][1] = eps*l0[k][1]; + l[k][2] = eps*l0[k][2]; + } + // further reduce the box using greedy reduction and check + // if it changed from the last step using the change of basis + // matrices r and r0 + greedy(l,r); + rotation_matrix(rot,lrot, l); + return !mat_same(r,r0); +} +void UEFBox::set_strain(const double ex, const double ey) +{ + theta[0] =winv[0][0]*ex + winv[0][1]*ey; + theta[1] =winv[1][0]*ex + winv[1][1]*ey; + theta[0] -= round(theta[0]); + theta[1] -= round(theta[1]); + + for (int k=0;k<3;k++) + { + double eps = exp(theta[0]*w1[k]+theta[1]*w2[k]); + l[k][0] = eps*l0[k][0]; + l[k][1] = eps*l0[k][1]; + l[k][2] = eps*l0[k][2]; + } + greedy(l,r); + rotation_matrix(rot,lrot, l); +} + +// this is just qr reduction using householder reflections +// m is input matrix, q is a rotation, r is upper triangular +// q*m = r +void rotation_matrix(double q[3][3], double r[3][3], const double m[3][3]) +{ + for (int k=0;k<3;k++) + for (int j=0;j<3;j++) + r[k][j] = m[k][j]; + + double a = -sqrt(col_prod(r,0,0))*r[0][0]/fabs(r[0][0]); + double v[3]; + v[0] = r[0][0]-a; + v[1] = r[1][0]; + v[2] = r[2][0]; + a = sqrt(v[0]*v[0]+v[1]*v[1]+v[2]*v[2]); + v[0] /= a; v[1] /= a; v[2] /= a; + double qt[3][3]; + for (int k=0;k<3;k++) + for (int j=0;j<3;j++) + { + qt[k][j] = (k==j) - 2*v[k]*v[j]; + q[k][j]= qt[k][j]; + } + mul_m2(qt,r); + a = -sqrt(r[1][1]*r[1][1] + r[2][1]*r[2][1])*r[1][1]/fabs(r[1][1]); + v[0] = 0; + v[1] = r[1][1] - a; + v[2] = r[2][1]; + a = sqrt(v[1]*v[1]+v[2]*v[2]); + v[1] /= a; + v[2] /= a; + for (int k=0;k<3;k++) + for (int j=0;j<3;j++) + qt[k][j] = (k==j) - 2*v[k]*v[j]; + mul_m2(qt,r); + mul_m2(qt,q); + // this makes r have positive diagonals + // q*m = r <==> (-q)*m = (-r) will hold row-wise + if (r[0][0] < 0){ neg_row(q,0); neg_row(r,0); } + if (r[1][1] < 0){ neg_row(q,1); neg_row(r,1); } + if (r[2][2] < 0){ neg_row(q,2); neg_row(r,2); } +} + + + +//sort columns in order of increasing length +void col_sort(double b[3][3],int r[3][3]) +{ + if (col_prod(b,0,0)>col_prod(b,1,1)) + { + col_swap(b,0,1); + col_swap(r,0,1); + } + if (col_prod(b,0,0)>col_prod(b,2,2)) + { + col_swap(b,0,2); + col_swap(r,0,2); + } + if (col_prod(b,1,1)>col_prod(b,2,2)) + { + col_swap(b,1,2); + col_swap(r,1,2); + } +} + + +// 1-2 reduction (Graham-Schmidt) +void red12(double b[3][3],int r[3][3]) +{ + int y = round(col_prod(b,0,1)/col_prod(b,0,0)); + b[0][1] -= y*b[0][0]; + b[1][1] -= y*b[1][0]; + b[2][1] -= y*b[2][0]; + + r[0][1] -= y*r[0][0]; + r[1][1] -= y*r[1][0]; + r[2][1] -= y*r[2][0]; + if (col_prod(b,1,1) < col_prod(b,0,0)) + { + col_swap(b,0,1); + col_swap(r,0,1); + red12(b,r); + } +} + +// The Semaev condition for a 3-reduced basis +void red3(double b[3][3], int r[3][3]) +{ + double b11 = col_prod(b,0,0); + double b22 = col_prod(b,1,1); + double b12 = col_prod(b,0,1); + double b13 = col_prod(b,0,2); + double b23 = col_prod(b,1,2); + + double y2 =-(b23/b22-b12/b22*b13/b11)/(1-b12/b11*b12/b22); + double y1 =-(b13/b11-b12/b11*b23/b22)/(1-b12/b11*b12/b22); + + int x1=0; + int x2=0; + double min = col_prod(b,2,2); + int x1v[2]; + int x2v[2]; + x1v[0] = floor(y1); x1v[1] = x1v[0]+1; + x2v[0] = floor(y2); x2v[1] = x2v[0]+1; + for (int k=0;k<2;k++) + for (int j=0;j<2;j++) + { + double a[3]; + a[0] = b[0][2] + x1v[k]*b[0][0] + x2v[j]*b[0][1]; + a[1] = b[1][2] + x1v[k]*b[1][0] + x2v[j]*b[1][1]; + a[2] = b[2][2] + x1v[k]*b[2][0] + x2v[j]*b[2][1]; + double val=a[0]*a[0]+a[1]*a[1]+a[2]*a[2]; + if (val<min) + { + min = val; + x1 = x1v[k]; + x2 = x2v[j]; + } + } + if (x1 || x2) + { + b[0][2] += x1*b[0][0] + x2*b[0][1]; + b[1][2] += x1*b[1][0] + x2*b[1][1]; + b[2][2] += x1*b[2][0] + x2*b[2][1]; + r[0][2] += x1*r[0][0] + x2*r[0][1]; + r[1][2] += x1*r[1][0] + x2*r[1][1]; + r[2][2] += x1*r[2][0] + x2*r[2][1]; + greedy_recurse(b,r); // note the recursion step is here + } +} + +// the meat of the greedy reduction algorithm +void greedy_recurse(double b[3][3], int r[3][3]) +{ + col_sort(b,r); + red12(b,r); + red3(b,r); // recursive caller +} + +// set r (change of basis) to be identity then reduce basis and make it unique +void greedy(double b[3][3],int r[3][3]) +{ + r[0][1]=r[0][2]=r[1][0]=r[1][2]=r[2][0]=r[2][1]=0; + r[0][0]=r[1][1]=r[2][2]=1; + greedy_recurse(b,r); + make_unique(b,r); +} + +// A reduced basis isn't unique. This procedure will make it +// "more" unique. Degenerate cases are possible, but unlikely +// with floating point math. +void make_unique(double b[3][3], int r[3][3]) +{ + if (fabs(b[0][0]) < fabs(b[0][1])) + { col_swap(b,0,1); col_swap(r,0,1); } + if (fabs(b[0][0]) < fabs(b[0][2])) + { col_swap(b,0,2); col_swap(r,0,2); } + if (fabs(b[1][1]) < fabs(b[1][2])) + { col_swap(b,1,2); col_swap(r,1,2); } + + if (b[0][0] < 0){ neg_col(b,0); neg_col(r,0); } + if (b[1][1] < 0){ neg_col(b,1); neg_col(r,1); } + if (det(b) < 0){ neg_col(b,2); neg_col(r,2); } +} + diff --git a/src/USER-UEF/uef_utils.h b/src/USER-UEF/uef_utils.h new file mode 100644 index 0000000000000000000000000000000000000000..94527a49b3a3419b4b7d5a843cd2f333cc91dfd4 --- /dev/null +++ b/src/USER-UEF/uef_utils.h @@ -0,0 +1,139 @@ + +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + http://lammps.sandia.gov, Sandia National Laboratories + Steve Plimpton, sjplimp@sandia.gov + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. + + Contributing author: David Nicholson (MIT) +------------------------------------------------------------------------- + + This class contains functions to calculate the evolution of the periodic + simulation box under elongational flow as described by Matthew Dobson + in the arXiv preprint at http://arxiv.org/abs/1408.7078 + + Additionally, there are methods to do a lattice reduction to further + reduce the simulation box using the method of Igor Semaev at + http://link.springer.com/chapter/10.1007%2F3-540-44670-2_13 +*/ + + +namespace LAMMPS_NS { +namespace UEF_utils { + +class UEFBox +{ + public: + UEFBox(); + void set_strain(const double, const double); + void step_deform(const double,const double); + bool reduce(); + void get_box(double[3][3], double); + void get_rot(double[3][3]); + private: + double l0[3][3]; // initial basis + double w1[3],w2[3], winv[3][3]; // omega1 and omega2 (spectra of automorphisms) + //double edot[3], delta[2]; + double theta[2]; + double l[3][3], rot[3][3], lrot[3][3]; + int r[3][3],a1[3][3],a2[3][3],a1i[3][3],a2i[3][3]; +}; + + +// lattice reduction routines +void greedy(double[3][3],int[3][3]); +void col_sort(double[3][3],int[3][3]); +void red12(double[3][3],int[3][3]); +void greedy_recurse(double[3][3],int[3][3]); +void red3(double [3][3],int r[3][3]); +void make_unique(double[3][3],int[3][3]); +void rotation_matrix(double[3][3],double[3][3],const double [3][3]); + +// A few utility functions for 3x3 arrays +template<typename T> +T col_prod(T x[3][3], int c1, int c2) +{ + return x[0][c1]*x[0][c2]+x[1][c1]*x[1][c2]+x[2][c1]*x[2][c2]; +} + +template<typename T> +void col_swap(T x[3][3], int c1, int c2) +{ + for (int k=0;k<3;k++) + { + T t = x[k][c2]; + x[k][c2]=x[k][c1]; + x[k][c1]=t; + } +} + +template<typename T> +void neg_col(T x[3][3], int c1) +{ + x[0][c1] = -x[0][c1]; + x[1][c1] = -x[1][c1]; + x[2][c1] = -x[2][c1]; +} + +template<typename T> +void neg_row(T x[3][3], int c1) +{ + x[c1][0] = -x[c1][0]; + x[c1][1] = -x[c1][1]; + x[c1][2] = -x[c1][2]; +} + +template<typename T> +T det(T x[3][3]) +{ + double val; + val = x[0][0]*(x[1][1]*x[2][2] - x[1][2]*x[2][1]); + val -= x[0][1]*(x[1][0]*x[2][2] - x[1][2]*x[2][0]); + val += x[0][2]*(x[1][0]*x[2][1] - x[1][1]*x[2][0]); + return val; +} + +template<typename T> +bool mat_same(T x1[3][3], T x2[3][3]) +{ + bool v = true; + for (int k=0;k<3;k++) + for (int j=0;j<3;j++) + v &= (x1[k][j]==x2[k][j]); + return v; +} + +template<typename T> +void mul_m1(T m1[3][3], const T m2[3][3]) +{ + T t[3][3]; + for (int k=0;k<3;k++) + for (int j=0;j<3;j++) + t[k][j]=m1[k][j]; + + for (int k=0;k<3;k++) + for (int j=0;j<3;j++) + m1[k][j] = t[k][0]*m2[0][j] + t[k][1]*m2[1][j] + t[k][2]*m2[2][j]; +} + +template<typename T> +void mul_m2(const T m1[3][3], T m2[3][3]) +{ + T t[3][3]; + for (int k=0;k<3;k++) + for (int j=0;j<3;j++) + t[k][j]=m2[k][j]; + + for (int k=0;k<3;k++) + for (int j=0;j<3;j++) + m2[k][j] = m1[k][0]*t[0][j] + m1[k][1]*t[1][j] + m1[k][2]*t[2][j]; +} + +} +}